Code Monkey home page Code Monkey logo

isovic / racon Goto Github PK

View Code? Open in Web Editor NEW
252.0 23.0 48.0 10.17 MB

Ultrafast consensus module for raw de novo genome assembly of long uncorrected reads. http://genome.cshlp.org/content/early/2017/01/18/gr.214270.116 Note: This was the original repository which will no longer be officially maintained. Please use the new official repository here:

Home Page: https://github.com/lbcb-sci/racon

License: MIT License

C++ 83.02% CMake 3.85% Python 8.93% Makefile 0.52% Meson 3.68%

racon's Introduction

Racon

Latest GitHub release Build status for gcc/clang Published in Genome Research

Consensus module for raw de novo DNA assembly of long uncorrected reads.

Description

Racon is intended as a standalone consensus module to correct raw contigs generated by rapid assembly methods which do not include a consensus step. The goal of Racon is to generate genomic consensus which is of similar or better quality compared to the output generated by assembly methods which employ both error correction and consensus steps, while providing a speedup of several times compared to those methods. It supports data produced by both Pacific Biosciences and Oxford Nanopore Technologies.

Racon can be used as a polishing tool after the assembly with either Illumina data or data produced by third generation of sequencing. The type of data inputed is automatically detected.

Racon takes as input only three files: contigs in FASTA/FASTQ format, reads in FASTA/FASTQ format and overlaps/alignments between the reads and the contigs in MHAP/PAF/SAM format. Output is a set of polished contigs in FASTA format printed to stdout. All input files can be compressed with gzip (which will have impact on parsing time).

Racon can also be used as a read error-correction tool. In this scenario, the MHAP/PAF/SAM file needs to contain pairwise overlaps between reads including dual overlaps.

A wrapper script is also available to enable easier usage to the end-user for large datasets. It has the same interface as racon but adds two additional features from the outside. Sequences can be subsampled to decrease the total execution time (accuracy might be lower) while target sequences can be split into smaller chunks and run sequentially to decrease memory consumption. Both features can be run at the same time as well.

Dependencies

  1. gcc 4.8+ or clang 3.4+
  2. cmake 3.2+

CUDA Support

  1. gcc 5.0+
  2. cmake 3.10+
  3. CUDA 9.0+

Installation

To install Racon run the following commands:

git clone --recursive https://github.com/lbcb-sci/racon.git racon
cd racon
mkdir build
cd build
cmake -DCMAKE_BUILD_TYPE=Release ..
make

After successful installation, an executable named racon will appear in build/bin.

Optionally, you can run sudo make install to install racon executable to your machine.

Note: if you omitted --recursive from git clone, run git submodule update --init --recursive before proceeding with compilation.

To build unit tests add -Dracon_build_tests=ON while running cmake. After installation, an executable named racon_test will be created in build/bin.

To build the wrapper script add -Dracon_build_wrapper=ON while running cmake. After installation, an executable named racon_wrapper (python script) will be created in build/bin.

CUDA Support

Racon makes use of NVIDIA's GenomeWorks SDK for CUDA accelerated polishing and alignment.

To build racon with CUDA support, add -Dracon_enable_cuda=ON while running cmake. If CUDA support is unavailable, the cmake step will error out. Note that the CUDA support flag does not produce a new binary target. Instead it augments the existing racon binary itself.

cd build
cmake -DCMAKE_BUILD_TYPE=Release -Dracon_enable_cuda=ON ..
make

Note: Short read polishing with CUDA is still in development!

Packaging

To generate a Debian package for racon, run the following command from the build folder -

make package

Usage

Usage of racon is as following:

racon [options ...] <sequences> <overlaps> <target sequences>

    # default output is stdout
    <sequences>
        input file in FASTA/FASTQ format (can be compressed with gzip)
        containing sequences used for correction
    <overlaps>
        input file in MHAP/PAF/SAM format (can be compressed with gzip)
        containing overlaps between sequences and target sequences
    <target sequences>
        input file in FASTA/FASTQ format (can be compressed with gzip)
        containing sequences which will be corrected

options:
    -u, --include-unpolished
        output unpolished target sequences
    -f, --fragment-correction
        perform fragment correction instead of contig polishing (overlaps
        file should contain dual/self overlaps!)
    -w, --window-length <int>
        default: 500
        size of window on which POA is performed
    -q, --quality-threshold <float>
        default: 10.0
        threshold for average base quality of windows used in POA
    -e, --error-threshold <float>
        default: 0.3
        maximum allowed error rate used for filtering overlaps
    --no-trimming
        disables consensus trimming at window ends
    -m, --match <int>
        default: 3
        score for matching bases
    -x, --mismatch <int>
        default: -5
        score for mismatching bases
    -g, --gap <int>
        default: -4
        gap penalty (must be negative)
    -t, --threads <int>
        default: 1
        number of threads
    --version
        prints the version number
    -h, --help
        prints the usage

only available when built with CUDA:
    -c, --cudapoa-batches <int>
        default: 0
        number of batches for CUDA accelerated polishing per GPU
    -b, --cuda-banded-alignment
        use banding approximation for polishing on GPU. Only applicable when -c is used.
    --cudaaligner-batches <int>
        default: 0
        number of batches for CUDA accelerated alignment per GPU
    --cudaaligner-band-width <int>
        default: 0
        Band width for cuda alignment. Must be >= 0. Non-zero allows user defined
        band width, whereas 0 implies auto band width determination.

racon_test is run without any parameters.

Usage of racon_wrapper equals the one of racon with two additional parameters:

...
options:
    --split <int>
        split target sequences into chunks of desired size in bytes
    --subsample <int> <int>
        subsample sequences to desired coverage (2nd argument) given the
        reference length (1st argument)
    ...

Contact information

For additional information, help and bug reports please send an email to one of the following: [email protected], [email protected], [email protected], [email protected]

Acknowledgment

This work has been supported in part by Croatian Science Foundation under the project UIP-11-2013-7353. IS is supported in part by the Croatian Academy of Sciences and Arts under the project "Methods for alignment and assembly of DNA sequences using nanopore sequencing data". NN is supported by funding from A*STAR, Singapore.

racon's People

Contributors

akkamesh avatar isovic avatar lanzju76 avatar larsbishop avatar msikic avatar nvericx avatar rvaser avatar shuang-broad avatar vellamike avatar

Stargazers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

Watchers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

racon's Issues

Crashes when SAM input file is used.

Instead of a PAF file, I'm giving racon a SAM file output by graphmap. It crashes with the following error:

Using PAF for input alignments. (graphmap.sam)

[13:26:30 main] Loading reads.
[13:26:33 main] Hashing qnames.
[13:26:33 main] Parsing the overlaps file.
[13:26:33 main] Unique overlaps will be filtered on the fly.
[Mon, 09 Jan 17 18:26:33 +0000 ERROR] #5: Unexpected value found! Overlaps are not formatted in the PAF format. Exiting.In function: 'ParsePAF'.

[Mon, 09 Jan 17 18:26:33 +0000 ERROR] #5: Unexpected value found! Overlaps are not formatted in the PAF format. Exiting.In function: 'ParsePAF'.
Exiting.

Is there a command line option that I'm missing?

Thanks

wrong default listed in help

Hello,

Minor thing in the help:
The line:
"
--mhap - Overlaps are in PAF format instead of MHAP. [false]
"
should be
"
--mhap - Overlaps are in MHAP format instead of PAF. [false]
"
given that it throws the following error when --mhap flag is not set and an *.mhap file is provided as input:
"
[Mon, 10 Jul 17 16:10:23 +0000 ERROR] #5: Unexpected value found! Overlaps are not formatted in the PAF format. Exiting. In function: 'ParsePAF'.
"

Racon seems to get stacked during consensus building

Hi,
I am trying to use racon to polish a fish miniasm assembly (~600 Mbases) from pacbio data.
I have tried my racon script on an ecoli assembly and it works fine, but on this fish it seems racon
get stucked at some point during the consensus generation.
To simplify the problem as much as possible I selected a unique contig (~5 Mbases) and aligned
about 50K reads against only this contig with bwa mem, then filtered out all supplementary, secondary and duplication alignments and tried to run racon on this subset, but it still seems to get stucked around the same point.

I am running racon v0.5.0 like this:
$raconhome/bin/racon -v 7 -M 5 -X -4 -G -8 -E -6 --bq 0 --sam -t 15 selected.fastq bwa.sorted.sam results/consensus-${dataset}-${suffix}-$previter.fasta results/consensus-${dataset}-${suffix}-$curriter.fasta

An example of output (-v 7) below, everytime it seems to get stucked in a slightly different position, but always around 0.05% of the consensus. The job seems to keep working, but even if I leave it running it just never ends. I have tried many subsettings but it just get stucked and never ends. it keeps using 15 cpus, but is not clear what it's doing, and no progress seems to be made...
Can you please advise what could be wrong? Maybe the pacbio accuracy could be too low?

Thank you very much!
Francesca

[14:44:41 main] Using SAM for input alignments. (bwa.sorted.sam)
[14:44:41 main] Parsing the SAM file.
[14:44:50 ConsensusFromAln] Running consensus - directly from alignments.
[14:44:50 ConsensusFromAln] Separating alignments to individual contigs.
[14:44:50 ConsensusFromAln] In total, there are 1 contigs for consensus, each containing:
[14:44:50 ConsensusFromAln] [0] utg000004l 50000 alignments, contig len: 5133663
[14:44:50 ConsensusFromAln] Starting consensus for contig 1 / 1 (100.00%): utg000004l
[14:44:50 src/consensus/consensus_sam.cc CreateConsensusAln LN:277] current_contig->get_sequence_length() = 5133663, parameters.window_len = 500, num_windows = 10268
[14:44:50 src/consensus/consensus_sam.cc CreateConsensusAln LN:291] CPU time for building the IntervalTree: 0.130000 sec.
[14:44:50 CreateConsensusAln] (thread_id = 0) Processing window: 2500 bp to 2999 bp (0.05%)[14:44:50 src/consensus/consensus_sam.cc CreateConsensusAln LN:316] , clk_total_extract = 0.000000, clk_total_spoa = 0.000000, coverage: 264x

Error: Unexpected value found! Could not find qname in the input contigs file!

Hello,

After having ran minimap/miniasm on ~55x of PacBio data, I used Racon and ended with the following error:

bin/racon -v 9 -t 16 filtered_subreads.fastq.gz 14smrt.paf 14smrt.gfa racon1_consensus.fa
[18:43:39 main] Using PAF for input alignments. (14smrt.paf)
[18:43:39 main] Loading reads.
[18:48:20 main] Hashing qnames.
[18:48:23 main] Parsing the overlaps file.
[18:48:23 main] Unique overlaps will be filtered on the fly.
[Wed, 08 Feb 17 17:48:23 +0000 ERROR] #5: Unexpected value found! Could not find qname 'm161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318' in the input contigs file! Exiting.In function: 'ParsePAF'.

[Wed, 08 Feb 17 17:48:23 +0000 ERROR] #5: Unexpected value found! Could not find qname 'm161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318' in the input contigs file! Exiting.In function: 'ParsePAF'.
Exiting.

However, if I check the .paf file:

grep "m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318" 14smrt.paf | head
m160911_135114_42266_c101051342550000001823235612291623_s1_p0/108988/1775_11679	9904	2584	9147	+	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	3012	991909	6905	255	cm:i:107
m160911_135114_42266_c101051342550000001823235612291623_s1_p0/108988/11719_13441	1722	659	1653	-	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	89610012	194	1044	255	cm:i:34
m160911_135114_42266_c101051342550000001823235612291623_s1_p0/113245/15907_27804	11897	1188	8493	-	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	3038451	308	8148	255	cm:i:39
m160911_135114_42266_c101051342550000001823235612291623_s1_p0/113245/27850_39524	11674	3858	11629	+	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	4919206	513	8715	255	cm:i:49
m160911_135114_42266_c101051342550000001823235612291623_s1_p0/19257/0_9033	9033	131	6625	+	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	4293	10082	657	6494	255	cm:i:71
m160830_160025_42266_c101051572550000001823235612291631_s1_p0/62000/5163_20500	15337	1906	11244	-	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	506	9901458	9401	255	cm:i:172
m160830_160025_42266_c101051572550000001823235612291631_s1_p0/62000/20545_37122	16577	3720	13189	+	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	196	9881581	9687	255	cm:i:192
m160830_160025_42266_c101051572550000001823235612291631_s1_p0/71105/16971_25751	8780	437	4443	-	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	215	408418	4006	255	cm:i:41
m160830_160025_42266_c101051572550000001823235612291631_s1_p0/71105/25795_42149	16354	4161	13950	+	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	279	10069	1597	9790	255	cm:i:192
m160830_160025_42266_c101051572550000001823235612291631_s1_p0/73351/0_8663	8663	50	2451	-	m161209_103737_42269_c101137592550000001823249505311710_s1_p0/108844/10223_20318	10095	59	243422	2401	255	cm:i:58

I don't get it... Here are my minimap/miniasm commands:

minimap/minimap -x ava10k -t24 filtered_subreads.fastq.gz filtered_subreads.fastq.gz | gzip -1 > 14smrt.paf.gz
miniasm/miniasm -f filtered_subreads.fastq.gz 14smrt.paf.gz > 14smrt.gfa

Thanks for your help!

ERROR: Reads are not specified in a format

Hi,

I am using racon, and get following error:
[01:45:17 main] Using PAF for input alignments. (/gpfs0/home/lzb0021/ouc/pacbio/ajap.paf)
[01:45:17 main] Loading reads.
ERROR: Reads are not specified in a format which contains quality information. Exiting.

The pacbio reads are indeed in fastq format, and the quality value is like this:

-+/,"..".-'--$&$$-./.(.-),..--,//.#$',,.)////--//+'&$-.+()%#)/(,++)&-++%&+(+(.).-)...-#.)/,&+.../.,.($#&&&#$#$)&&+%-%+&
'''-&'##$&(&&'&%+&(%/(),$.&+.++#+,(..((&)%--)(&&)-+##'#.-"..$,,,++(..$')()$%#&)+&+&##$#)&)'($##$($#$'$'((+&'%$'',,
,+,)-,#(
)&,".).-&(($(%#'$&amp;&%&&%#&-"+-%(-(-)+,+(--+%(.,)%,%#(+'+#($(*%$'-.%,))&&)&,(%'&&')+#&,)..&,'&),,%&++(+#)%&+)
..%-/'#(,,+#$###"$%))#',.(
$%##%%(,'(#),%&%$)%+++&,++(+%(,$$#$$'(%'##+,+$**)-$"(.$.+..#(--,#&,,).,&(,++#(''(+.
&,%
(.#.%////+-#-('&,$%$#$$$$$####%(#+,-&'"'#'+()$&.-.-,$'('-%$$'-$%&.-+().-#++)&&)(%')$&'&&$&)$',%,&-),&&),''(,&
&$+++)./&.-%-$'/.)$#&#"###$$#$#%(.),$$,-.&+.)&#/'-(//()+%.#%-()...++$((#$$-)&)(.-&))(-#--&$&$#$+)#-&&((('-)),(,()
&'-&-,-"####%'+'&"$'-(%)+(-)'&'-%$&-&&&&&&#%'.)$)#%--$'''$'&('&&+-)%%&&&',-(()&&%)(..,-/-,+(-&&&'&"%&)'.-.,+(&,,).,
#$$#########""#"&+,+$"''-)..,.-$'"$#&#+(-.&+(+"+&),&+++&)+'),+(/&',%+'%*(&',))&%&#$&"$$$#$%%$()+((%&%(&$,'('%%$#%$'&&')
)%
+&),,,+)/./)+#$$##$$##$(%#"%%&,-'%&)(%%-)-'.).#'%)&+'$%&&$(-&%&###'&()+'$.+.-&'',+-+()++#))',(#)&%&,.,/.(,%$-)#+%
+.$(-&,%"%"#$',,+%')'.-,'-'#$"$$$$$%)-$)(,+'%#&-$#%#"$'&.))../+)))&(())))#(-),-.&$**+++)&+'%&)..+--%--,')/+'-','+("$$
$#"$$$######%&.#&.+.&#$'-#.,),,).,.+%+'$(.%//..&%&///..-,/.-,)+,'&(+'%'&'&&#'&)%%$(++)&//-/'..(+/+.)&."//+.../%
)%&,%&%&(-().))#&%$$$%"+--)./**(+-')//-,,+(.,),,-&,(.-&.+$&+%+$%%$$#####"&-'--%&#'#$#&+($&$(&'('%%(,-%'(&&+$%$(-#%#+#,
%)),+%#%'%-''+-++-+#,+)(,$%-%-".(
--$$%$"#""####$#&(%&-)+'$%",'-,'('%#%$%(--''.-#
+'.)'')"''..-+&%$'(-.+#(..'),%+-.(-()+/
//
"+/..,))''##&#-&,%%#%"##'+#%'-,**+-#%..())(-$#')&$$',#$$$,**&'%#'(,(-%&%#%%&'#,,,,)./,,+'.#)..+,(#'##$$%&&+&('.))
&.+/
%..(&-(%$#$%'-('-,'&+-+-+-.(.$&'#&,'#&#'-+..$,#.&).($(..',,+(#'$%$%#$#%%''((./)(-///.'//,)).().)),##%#&##+$#('%
&($%&,&,-.&#))$%)&&#$#')'
#'%+%-&++'&&&'('++)(+-)%$'$)',.&,''.-$&%($%$##%""$#-#'(%&%(-))($%##-+'"#'-.))'$-','($-'..,).
++
#'+.&',,,)++++++++++,++)...++$(()(%+%$'+##$(-.',%./++'(-#%$#$##%%)/'$/--'&%%$%&'#((&-.('#.,%-/,,+#%)&(**
&())'+&$%&%)-/-+
'(
(&)**'%+,),$#./..+,++..#&%#--(+/+'-+(").+//.+.)'--,',,-++++**%$')&,&$%&%)#(($((('',&&()%$),.&...++*
+-,,,++(',###(./',(')'(%%%%%($%$$$#########$%#'$')%)-+(#.--"&.-+&+)(%')&())))%')))(()()(#)'&#&).(.",+($--&$#&%)#.+&)/"
,+,.'.+-++,('(/#)$.
-%'('$$$#$&$&%##$%$"###%($...))%%-%//..+/,-,,&$-+$"#(#&(('-&%).,%&-",%%%#$$(.(/,".+-,,.(/%/,(.+(%,'#
%#),
)$%'%')%%#%&%''%)&,/.,+..##&&)))(+"$+)''$%)&'&'').$.$..#&-,,',,)/+,&(&-'$$&)--,)"&().///%+-'&((%'()&&)('(((+-).$
+&,).#(/+)+&+'$"#$&,+()(&-#$&#,%&+#&'#%##&,-**((#''($-$(()$)(.(".%&%$#$%+$&'%")'-,-%-'&&)##'%')&--)'+%-.'#)/&+,,+
+&)+'(+.'+).,-""&#%$(-*.,-.%)$'$'&&%%)%('-$'$$(##''

Could you please provide any suggestions here?

Thanks!

racon crashes on MAP006-1 miniasm contigs

I am trying to run miniasm + racon on the E. coli K-12 MG1655 SQK-MAP006-1 as described in your preprint. I have racon crashing on it (first consensus step). I did the following. Note that I use the latest miniasm and minimap (still the same git commits as listed in your paper) as well as the latest racon (commit ID 6a4bd97).

READS=MAP006-1_2D_pass.fasta #http://nanopore.s3.climb.ac.uk/MAP006-1_2D_pass.fasta
PREFIX=MAP006-1
../../../src/minimap/minimap -Sw5 -L100 -m0 -t8 ${READS} ${READS} | gzip -1 >${PREFIX}.paf.gz
../../../src/miniasm/miniasm -f ${READS} ${PREFIX}.paf.gz > ${PREFIX}.gfa
# Convert to fasta
head -n 1 ${PREFIX}.gfa | awk '{print ">"$2; print $3}' >${PREFIX}.utg.fasta

I then used a script to run racon:

prefix=MAP006-1
reads=MAP006-1_2D_pass.fasta
assembly=${prefix}.utg.fasta
mapped=${prefix}.utg_reads_mapped1.paf
consensus=${prefix}.utg_reads_racon1.fasta

# programs
minimap=../../../src/minimap/minimap
racon=../../../src/racon/bin/racon

set -x

# map
${minimap} ${assembly} ${reads} > ${mapped}

# consensus
${racon} -t 8 ${reads} ${mapped} ${assembly} ${consensus}

As a result, these commands were run:

../../../src/minimap/minimap MAP006-1.utg.fasta SQK-MAP006-1/MAP006-1_2D_pass.fasta

This finished fine and resulted in a 5.5M .paf file.

../../../src/racon/bin/racon -t 8 SQK-MAP006-1/MAP006-1_2D_pass.fasta MAP006-1.utg_reads_mapped1.paf MAP006-1.utg.fasta MAP006-1.utg_reads_racon1.fasta
[14:00:10 main] Using PAF for input alignments. (MAP006-1.utg_reads_mapped1.paf)
[14:00:10 main] Loading reads.
[14:00:12 main] Hashing qnames.
[14:00:12 main] Parsing the PAF file.
[14:00:12 main] Filtering overlaps.
[14:00:12 main] Aligning overlaps.

[14:00:12 AlignMHAP] Aligning overlap: 5 / 24770 (0.02%), skipped 0 / 24770 (0.00%)run_racon.sh: line 17: 96950 Segmentation fault      (core dumped) ${racon} -t 8 ${reads} ${mapped} ${assembly} ${consensus}

What could have gone wrong?

For bigger genomes?

I have been trying racon out on a plant genome assembled by miniasm (raw pacbio reads), the assembled genome size is 547 Mbp (expected size 750Mbp) and the .paf file is 300Gb. I have tried giving upto 720GB on a cluster to Racon, but the job gets killed at the ParsePAF stage.

Do you have any suggestions regarding how I could make it work for a large genome ?

Release on Github

Hi,
Could you please produce a release on Github, because I started to create Bioconda package and in my understanding make modules is not supported?

Thank you in advance,

Michal

Quality log

Hi,

maybe it would be possible to list the number of corrected bases per contig in an output log. This would be helpful for those with large genomes from novel strains/genotypes who do not have a perfect reference sequence to compare to.

Maybe something like
contig_name contig_length reads_aligned coverage bases_improved

For example, I ran racon once, then realigned using minimap and ran racon again. I have been using mummers dnadiff to check for differences between the two contigs but interpreting output for a lot of contigs is also quite involved.

Thanks for a nice and fast tool,
Colin

error: no member named 'abs' in namespace 'std'

Racon fails to compile with clang 800.0.42.1 on MacOS 10.11.6.

Note that libc++ unexpectedly defines std::abs(float) in cmath and std::abs(int) in cstdlib.
See http://en.cppreference.com/w/cpp/numeric/math/abs

Error

codebase/seqlib/src/libs/opal.cc:1304:45: error: no member named 'abs' in namespace 'std'; did you mean simply 'abs'?

Fix

diff --git a/private/tmp/racon-20170222-8113-p8dp0x/racon-v0.5.0/codebase/seqlib/src/libs/opal.cc.orig b/private/tmp/racon-20170222-8113-p8dp0x/racon-v0.5.0/codebase/seqlib/src/libs/opal.cc
index f819e6db..0636bae6 100644
--- a/codebase/seqlib/src/libs/opal.cc
+++ b/codebase/seqlib/src/libs/opal.cc
@@ -20,6 +20,7 @@
 #include <algorithm>
 #include <cassert>
 #include <climits>
 #include <cstdio>
+#include <cstdlib>
 #include <limits>
 #include <vector>

installation error

Hi,

I am trying to install Racon, but get the following error:

Receiving objects: 100% (390/390), 219.53 KiB, done.
Resolving deltas: 100% (270/270), done.
fatal: reference is not a tree: c649058e49e1c2d2f9919964219582a447efe6a1
Unable to checkout 'c649058e49e1c2d2f9919964219582a447efe6a1' in submodule path 'codebase/spoa'
Makefile:49: recipe for target 'modules' failed
make: *** [modules] Error 1

I have no idea how to solve this, so please help.
Bob

Question: use Racon to polish?

I was curious if you thought Racon would suitable as a long read polisher. E.g. if one had a completed assembly which is 99.9+% correct, could Racon use long read alignments to help fix up the remaining few SNPs and indels?

I'm thinking of something like GenonmicConsensus or Nanopolish, but those are both specific to the sequencing technology. Since Racon takes aligned FASTQ as input, I thought it could perhaps be a long read polisher that is sequencing platform-agnostic.

If you do think it's suitable for this sort of thing, then I'll also throw in a feature request: optionally outputting a variants file which shows the differences between the raw input and the consensus output. That might not make sense for a Miniasm input (there'd be too many), but it could be very helpful when polishing a mostly-finished genome.

simultaneous racon runs cause later one(s) to fail

If I have one racon run going, and start another one, even in a cluster environment, the second one will fail with "##### Illegal instruction" (where ##### varies). I've tried looking for files in /tmp, or in the temp directory of the racon build folder, but nothing stands out. They are running on the same file system, so that's why I suspect some sort of temp file overlap.

Otherwise, runs of the example data complete fine, and if I run one racon job at a time it appears to run fine.

Racon error correction - segmentation fault

Hello,

I'm trying to run racon to correct raw pacbio reads from a plant genome (~900Mb size) overlapped with minimap. I get a segmentation fault when parsing the overlaps file. My paf file is 749Gb size, while my fastq is 124Gb big. I could try to rename read IDs of both paf and fastq file as you suggested in other threads, but I'd like to know if you think, given the size of the input, that this would be enough to load this into memory. My machine has 1Tb RAM.

I also have another paf file obtained from mhap overlaps performed within canu. This one has 'only' a 377Gb size, but I can't get a fastq for those reads because those were filtered with DEXTRACTOR. I could create a new one with fake quality tags, but do you plan in a near future to allow fasta input, or fastq is really necessary for the analysis ? Isn't quiver or arrow information more useful for pacbio data?

Thanks in advance,
Pedro

racon --help does not work, and please add racon --version

Thanks!

โฏโฏโฏ racon --version
ERROR: Unknown argument '--version'. Exiting.
โฏโฏโฏ racon --help
ERROR: Not all required arguments specified. Parameter 'reads' missing a value. Exiting.

Please write the output of racon --help to stdout rather than stderr so that racon --help | less works. racon --help should return exit status 0 (successful) rather than exit status 1 (failure).

Contigs missing in the output

HI,

I noticed that some contigs are missing in the final output. Are contigs with insufficient coverage thrown out?
Could you include those or write them in an extra file?

Thanks
Chris

samscripts make error

Hi all,
I get the following error during make modules

fatal: reference is not a tree: 8225661d48e8c341dc46f880bdf5d02c37cc6adf
Unable to checkout '8225661d48e8c341dc46f880bdf5d02c37cc6adf' in submodule path 'codebase/samscripts'
Makefile:49: recipe for target 'modules' failed
make: *** [modules] Error 1

module tools and module -j run smoothly
Examples also run without errors.

My distribution details:

DISTRIB_ID=Ubuntu
DISTRIB_RELEASE=16.04
DISTRIB_CODENAME=xenial
DISTRIB_DESCRIPTION="Ubuntu 16.04.1 LTS"

All dependencies installed.

Thank you in advance,
Freddy

invalid pointer

Hi I have got free(): invalid pointer in the first racon run

[17:07:36 ConsensusFromOverlaps] Started processing contig 1 / 331983 (0.00%): utg000001l
[17:07:36 ConsensusFromOverlaps] (thread_id = 0) Aligning overlaps for contig 1 / 331983 (0.00%): utg000001l
[17:07:37 AlignOverlaps] Aligning overlap: 17 / 287 (6.27%), skipped 0 / 287 (0.00%)*** Error in `./bin/racon': free(): invalid pointer: 0x00007f3024000a1b ***
*** Error in `./bin/racon': free(): invalid pointer: 0x00007f3110000a19 ***
*** Error in `./bin/racon': free(): invalid pointer: 0x00007f310c000a19 ***
Aborted

I run racon in the following way:

awk '{print ">"$2; print $3}' fruit/fruit.gfa | fold >  fruit/fruit.gfa.fasta

minimap fruit/fruit.gfa.fasta \
        /scratch/fruit-data/RSnSeQ_110fruit.fastq \
        > fruit/fruit.gfa1.paf

./bin/racon -t 25 \
        /scratch/fruit-data/RSnSeQ_110fruit.fastq \
        fruit/fruit.gfa1.paf \
        fruit/fruit.gfa.fasta \
        fruit/fruit.racon1.fasta

What did I miss?

Thank you in advance.

Michal

Number of working threads

Hi there !

I just wanted to confirm with you that as far as to now, Racon runs only with one thread.
Thus, it is unfit to be used on an HPC for a genome wide job.

Thank you,

Anne-Lise

Support for .las

Hello,

I'm one of the developers of HINGE. We have been experimenting with integrating Racon into our pipeline. We like the current results but our current pipeline is based on DAligner, which we find to be more sensitive than Minimap.

Would it be possible for you guys to make Racon compatible with .las alignment files (instead of Minimap's .paf files)?

Heng Li has a script for converting .las to .paf but it seems to only work for pairwise alignment files and not for the reads-to-reference .las (which we need for consensus).

Thanks,

ilan

/bin/ld: cannot find -lstdc++

Keep getting this error when trying to run make on racon. System say's file is installed. I am using Cent 7. Can anybody please shed some insights as to why I am getting this.

'floor' is not a member of 'std' error when executing "make tools"

Hi,
I have installed Racon, but during the installation, in the make tools step, I get the following error:

src/graphmap/region_selection.cc: In member function 'int GraphMap::RegionSelectionNoCopy_(int64_t, MappingData*, std::vector<std::shared_ptr<is::MinimizerIndex> >&, const SingleSequence*, const ProgramParameters*)':
src/graphmap/region_selection.cc:177:56: error: 'floor' is not a member of 'std'
   float min_allowed_bin_value = std::max(2.0f, (float) std::floor(parameters->min_bin_percent * max_bin_value));
                                                        ^
src/graphmap/region_selection.cc:177:56: note: suggested alternative:
In file included from /usr/include/features.h:361:0,
                 from /usr/include/string.h:27,
                 from src/graphmap/region_selection.cc:8:
/usr/include/bits/mathcalls.h:185:1: note:   'floor'
 __MATHCALLX (floor,, (_Mdouble_ __x), (__const__));
 ^

Apparently Racon seems to run anyway.

bam for consensus

Hi,

Does racon accepts bam files instead of sam files for the consensus calculation or do we need convert bam to sam in order to use it?

Cheers,

racon within qsub

Hi all,

I am trying to use racon within a qsub script, but I find that while running racon directly from the terminal gives me readable output, running racon from a qsub script always gives me empty output.
For example the command
racon 2>&1 | wc -c
Gives me completely different results when run within the terminal (result: 2835) than when run within a qsub script (result: 0).
Any ideas/help?

Best wishes,
Nicola

Job Killed (memory swapping instead of use of free ram ?)

Hi

I'm trying to run your script on a vegetal genome (circa 600 Mb)
The input files were generated by using minimap and miniasm as recommanded.
But when I want to run racon, I have this error :

racon: Mon Sep 19 14:53:43 CEST 2016
[14:53:49 main] Using PAF for input alignments. (/mnt/cbib/Vitireseq/Racon_assembly_Vitireseq_random_18_SMRT_5kb/vriparia_racon_random_18_smrt_5kb_reads.paf)
[14:53:49 main] Loading reads.
[15:00:07 main] Hashing qnames.
[15:00:12 main] Parsing the overlaps file.
/var/lib/torque/mom_priv/jobs/33221.jarvis.SC: line 72: 51733 Killed                  racon -v 9 -t 8 $READS $OVERLAPS_PAF $RAW_CONTIGS $PBS_O_WORKDIR/Racon_assembly_Vitireseq_random_18_SMRT_5kb/vriparia_racon_random_18_smrt_5kb_reads_consensus.fasta
Exit Code: 137
Date fin: Mon Sep 19 15:34:31 CEST 2016
Job finished

I have tried to use the verbose debug option (-v 9) but it doesn't work

Thanks for your help

Regards

Alexis

two files are missing

Hello Racon:

I plan to run Racon using example data, following your instruction. However, it seems there are two files missing.

First, in your 'Quick start' section, it says:
Run an example script:

./example1-paf-lambda.sh

However, it seems there is no such a file in racon/ directory.

Second, in 'Usage' section, it says:
Consensus from mappings/overlaps in PAF/MHAP format

Generate mappings of reads to the layout using, e.g., Minimap:
tools/minimap/minimap test-data/lambda/layout-miniasm.gfa.fasta test-data/lambda/reads.fastq > test-data/lambda/mappings.paf
Again, there is no file called 'layout-miniasm.gfa.fasta' in test-data/lambda/ directory. Instead, I can find this 'layout-miniasm.gfa'.

So, how to find these files? Thanks.

correct reads

Hi๏ผŒ
I got 230GB pacbio reads and I want to correct it . I used minimap to detect the overlap , after five days I got a 16T *.paf...LOL, and then I want to use racon to correct the reads, could you give me some advice? Can I split the *.paf file? and how much memory will it use?

illegal instruction error

Hi,
I am trying to run racon on some nanopore yeast data but it crashes with the error:
14645 Illegal instruction $raconhome/bin/racon /s288c_ontreads_pass_plus2r9.fq mappings.paf layout_miniasm.fasta consensus.fasta

I was able to run a previous version of racon on the same data and using graphmap (github commit 28980be), but if I try the newest version with minimap, as suggested in the README I get the above error. Minimap seems to work fine and the contigs from miniasm look reasonable, so I don't know what can be wrong, can you help me figure it out? Thank you in advance for any help!

I ran it in this way:

# create contigs from minimap+miniasm:
minimap -Sw5 -L100 -m0 -t8 s288c_ontreads_pass_plus2r9.fq s288c_ontreads_pass_plus2r9.fq | gzip -1 > reads.paf.gz
miniasm -f s288c_ontreads_pass_plus2r9.fq reads.paf.gz > reads.gfa
awk '$1 ~/S/ {print ">"$2"\n"$3}' reads.gfa > layout_miniasm.fasta
# align raw reads to raw contigs:
minimap layout_miniasm.fasta $reads > mappings.paf
# run racon:
$raconhome/bin/racon s288c_ontreads_pass_plus2r9.fq mappings.paf layout_miniasm.fasta consensus.fasta

The output is in the attached file.
output.txt

I downloaded and installed racon like this:
git clone https://github.com/isovic/racon.git && cd racon && make modules && make tools && make -j

I also tried to run racon on the same data using as template the script example2-paf-pipe-lambda.sh, this created a consensus file, but crashed with the same error:

...
...
[12:21:48 ConsensusDirectFromOverlaps] [25] utg000026l 28 alignments, contig len: 12064
[12:21:48 ConsensusDirectFromOverlaps] [26] utg000027l 67 alignments, contig len: 35001

[12:21:48 ConsensusDirectFromOverlaps] Started processing contig 1 / 27 (3.70%): utg000001l
[12:21:48 ConsensusDirectFromOverlaps] (thread_id = 0) Aligning overlaps for contig 1 / 27 (3.70%): utg000001l
[12:21:58 AlignOverlaps] Aligning overlap: 2547 / 2548 (100.00%), skipped 0 / 2548 (0.00%)
./example2-paf-pipe-lambda.sh: line 39: 37897 Done $raconhome/tools/minimap/minimap $contigs $reads
37898 Illegal instruction | $raconhome/bin/racon -M 5 -X -4 -G -8 -E -6 --bq 10 -t ${threads} ${reads} - ${contigs} ${consensus}
Racon exited.

Failed to run python scripts due to python header.

I was not able to run the examples, python failed to import numpy. I'm using anaconda for setting up my env, would be great if you could change the python header in the scripts from /usr/bin/python to /usr/bin/env python

Racon 0.5.0 release fails to build

Hello, I'm trying to install racon for testing, but I cannot get it to work. I've tried both installing from source via git clone, as instructed on the README, as well as installing the tarball, which yields:

[135][Wed Apr 26][15:14:07][dbrowne][racon-0.5.0]make
Makefile:81: "*** WARNING g++ minor version <7 ***"
mkdir -p obj_linux/src/consensus/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/"  -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread -march=native -o obj_linux/src/consensus/consensus_overlap.o src/consensus/consensus_overlap.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
In file included from src/consensus/consensus_overlap.cc:9:
./src/consensus/consensus.h:11:10: fatal error: 'sequences/single_sequence.h' file not found
#include "sequences/single_sequence.h"
         ^
1 error generated.
make: *** [obj_linux/src/consensus/consensus_overlap.o] Error 1

Trying to install via git clone, make modules seems to work:

[101][Wed Apr 26][15:07:59][dbrowne][racon]make modules
git submodule update --init --recursive
Submodule 'codebase/argparser' (https://github.com/isovic/argparser.git) registered for path 'codebase/argparser'
Submodule 'codebase/samscripts' (https://github.com/isovic/samscripts.git) registered for path 'codebase/samscripts'
Submodule 'codebase/seqlib' (https://github.com/isovic/seqlib.git) registered for path 'codebase/seqlib'
Submodule 'codebase/spoa' (https://github.com/rvaser/spoa) registered for path 'codebase/spoa'
Cloning into '/Users/dbrowne/Desktop/Devarenne_Lab/Software/racon/codebase/argparser'...
Cloning into '/Users/dbrowne/Desktop/Devarenne_Lab/Software/racon/codebase/samscripts'...
Cloning into '/Users/dbrowne/Desktop/Devarenne_Lab/Software/racon/codebase/seqlib'...
Cloning into '/Users/dbrowne/Desktop/Devarenne_Lab/Software/racon/codebase/spoa'...
Submodule path 'codebase/argparser': checked out '72af9764acefbcc92ff76e3aba8a83d9a3e33671'
Submodule path 'codebase/samscripts': checked out 'cd7440fbbffafd76f40b15973c93acbe6111265a'
Submodule path 'codebase/seqlib': checked out 'b269c54358e8d54af0b0cacc88bf6ce2e6d91f3c'
Submodule path 'codebase/spoa': checked out 'b29e10ba822c2c47dfddf3865bc6a6fea2c3d69b'
Submodule 'vendor/bioparser' (https://github.com/rvaser/bioparser) registered for path 'codebase/spoa/vendor/bioparser'
Cloning into '/Users/dbrowne/Desktop/Devarenne_Lab/Software/racon/codebase/spoa/vendor/bioparser'...
Submodule path 'codebase/spoa/vendor/bioparser': checked out 'bf94252ae60e7cd977279cda23cd8fedcfea86a9'
cd codebase/spoa && git checkout overlap
Previous HEAD position was b29e10b... Submodule update
Branch overlap set up to track remote branch overlap from origin.
Switched to a new branch 'overlap'

But then make tools fails:

[102][Wed Apr 26][15:08:07][dbrowne][racon]make tools
mkdir -p tools; cd tools; git clone https://github.com/isovic/graphmap.git; cd graphmap && make modules && make -j
Cloning into 'graphmap'...
remote: Counting objects: 8280, done.
remote: Total 8280 (delta 0), reused 0 (delta 0), pack-reused 8280
Receiving objects: 100% (8280/8280), 22.06 MiB | 5.08 MiB/s, done.
Resolving deltas: 100% (5882/5882), done.
git submodule update --init --recursive
Submodule 'codebase/argumentparser' (https://github.com/isovic/argumentparser.git) registered for path 'codebase/argumentparser'
Submodule 'codebase/gindex' (https://github.com/isovic/gindex) registered for path 'codebase/gindex'
Submodule 'codebase/seqlib' (https://github.com/isovic/seqlib.git) registered for path 'codebase/seqlib'
Cloning into '/Users/dbrowne/Desktop/Devarenne_Lab/Software/racon/tools/graphmap/codebase/argumentparser'...
Cloning into '/Users/dbrowne/Desktop/Devarenne_Lab/Software/racon/tools/graphmap/codebase/gindex'...
Cloning into '/Users/dbrowne/Desktop/Devarenne_Lab/Software/racon/tools/graphmap/codebase/seqlib'...
Submodule path 'codebase/argumentparser': checked out '72af9764acefbcc92ff76e3aba8a83d9a3e33671'
Submodule path 'codebase/gindex': checked out 'b1fb5ad35763632db66377348bb16fec29f381e4'
Submodule 'codebase/seqlib' (https://github.com/isovic/seqlib) registered for path 'codebase/gindex/codebase/seqlib'
Cloning into '/Users/dbrowne/Desktop/Devarenne_Lab/Software/racon/tools/graphmap/codebase/gindex/codebase/seqlib'...
Submodule path 'codebase/gindex/codebase/seqlib': checked out 'bcfbcb1c77461c300d2ec0de03c0e1657a95cde2'
Submodule path 'codebase/seqlib': checked out '61ce79526e7e35b68057565caaf20d6ddc5906a0'
# git submodule foreach git pull origin master
Makefile:100: "*** WARNING g++ minor version <7 ***"
mkdir -p obj_linux/codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/
mkdir -p obj_linux/codebase/argumentparser/src/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/utils.o codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/utils.cpp
mkdir -p obj_linux/codebase/argumentparser/src/
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/argumentparser/src/argparser.o codebase/argumentparser/src/argparser.cc
mkdir -p obj_linux/codebase/gindex/src/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/argumentparser/src/example.o codebase/argumentparser/src/example.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/gindex/src/main.o codebase/gindex/src/main.cc
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/test.o codebase/seqlib/src/test.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/
mkdir -p obj_linux/codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/divsufsort.o codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/divsufsort.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/sssort.o codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/sssort.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/trsort.o codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/trsort.cc
mkdir -p obj_linux/codebase/gindex/src/minimizer_index/
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/gindex/src/minimizer_index/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/gindex/src/minimizer_index/compiled_shape.o codebase/gindex/src/minimizer_index/compiled_shape.cc
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/gindex/src/minimizer_index/experimental.o codebase/gindex/src/minimizer_index/experimental.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/gindex/src/minimizer_index/
mkdir -p obj_linux/codebase/gindex/src/minimizer_index/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/gindex/src/minimizer_index/index_pos.o codebase/gindex/src/minimizer_index/index_pos.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/gindex/src/minimizer_index/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/gindex/src/minimizer_index/minimizer_generator.o codebase/gindex/src/minimizer_index/minimizer_generator.cc
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/gindex/src/minimizer_index/minimizer_index.o codebase/gindex/src/minimizer_index/minimizer_index.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/gindex/src/minimizer_index/
mkdir -p obj_linux/codebase/seqlib/src/libs/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/gindex/src/minimizer_index/seed.o codebase/gindex/src/minimizer_index/seed.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/libs/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/libs/edlib.o codebase/seqlib/src/libs/edlib.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/libs/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/libs/edlibcigar.o codebase/seqlib/src/libs/edlibcigar.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/log_system/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/libs/opal.o codebase/seqlib/src/libs/opal.cc
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/log_system/log_system.o codebase/seqlib/src/log_system/log_system.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/sequences/
mkdir -p obj_linux/codebase/seqlib/src/sequences/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/sequences/sequence_alignment.o codebase/seqlib/src/sequences/sequence_alignment.cc
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/sequences/sequence_alignment_test.o codebase/seqlib/src/sequences/sequence_alignment_test.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/sequences/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/sequences/sequence_file.o codebase/seqlib/src/sequences/sequence_file.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/sequences/
mkdir -p obj_linux/codebase/seqlib/src/sequences/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/sequences/sequence_gfa.o codebase/seqlib/src/sequences/sequence_gfa.cc
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/sequences/sequence_gfa_test.o codebase/seqlib/src/sequences/sequence_gfa_test.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/sequences/
mkdir -p obj_linux/codebase/seqlib/src/utility/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/sequences/single_sequence.o codebase/seqlib/src/sequences/single_sequence.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/utility/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/utility/evalue.o codebase/seqlib/src/utility/evalue.cc
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/utility/evalue_constants.o codebase/seqlib/src/utility/evalue_constants.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/codebase/seqlib/src/utility/
mkdir -p obj_linux/codebase/seqlib/src/utility/
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/utility/tictoc.o codebase/seqlib/src/utility/tictoc.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
mkdir -p obj_linux/src/alignment/
codebase/seqlib/src/utility/tictoc.cc:17:17: error: use of undeclared identifier 'CLOCK_MONOTONIC_RAW'
  clock_gettime(CLOCK_MONOTONIC_RAW, &start_);
                ^
codebase/seqlib/src/utility/tictoc.cc:21:17: error: use of undeclared identifier 'CLOCK_MONOTONIC_RAW'
  clock_gettime(CLOCK_MONOTONIC_RAW, &stop_);
                ^
codebase/seqlib/src/utility/tictoc.cc:36:17: error: use of undeclared identifier 'CLOCK_MONOTONIC_RAW'
  clock_gettime(CLOCK_MONOTONIC_RAW, &stop);
                ^
3 errors generated.
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/codebase/seqlib/src/utility/utility_general.o codebase/seqlib/src/utility/utility_general.cc
make[1]: *** [obj_linux/codebase/seqlib/src/utility/tictoc.o] Error 1
make[1]: *** Waiting for unfinished jobs....
g++ -static-libgcc -static-libstdc++ -D__cplusplus=201103L -I"./src/" -I"/usr/include/" -I"codebase/seqlib/src/libs/seqan-library-2.0.1/include" -I"codebase/seqlib/src/libs/libdivsufsort-2.0.1-64bit/" -Icodebase/argumentparser/src -Icodebase/gindex/src -Icodebase/seqlib/src -DRELEASE_VERSION -O3 -fdata-sections -ffunction-sections -c -fmessage-length=0 -ffreestanding -fopenmp -m64 -std=c++11 -Werror=return-type -pthread  -o obj_linux/src/alignment/alignment.o src/alignment/alignment.cc
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
clang: warning: argument unused during compilation: '-static-libgcc'
clang: warning: argument unused during compilation: '-static-libstdc++'
In file included from codebase/gindex/src/minimizer_index/experimental.cc:8:
In file included from codebase/gindex/src/minimizer_index/minimizer_index.h:11:
./src/sparsehash/dense_hash_map:106:10: fatal error: 'tr1/functional' file not found
#include HASH_FUN_H                 // for hash<>
         ^
./src/sparsehash/internal/sparseconfig.h:10:20: note: expanded from macro 'HASH_FUN_H'
#define HASH_FUN_H <tr1/functional>
                   ^
In file included from codebase/gindex/src/minimizer_index/minimizer_index.cc:8:
In file included from codebase/gindex/src/minimizer_index/minimizer_index.h:11:
./src/sparsehash/dense_hash_map:106:10: fatal error: 'tr1/functional' file not found
#include HASH_FUN_H                 // for hash<>
         ^
./src/sparsehash/internal/sparseconfig.h:10:20: note: expanded from macro 'HASH_FUN_H'
#define HASH_FUN_H <tr1/functional>
                   ^
codebase/seqlib/src/sequences/sequence_alignment_test.cc:42:84: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
    printf ("%d %c, read = %ld, ref = %ld\n", split_ops[i].count, split_ops[i].op, split_ops[i].pos_query, split_ops[i].pos_ref);
                           ~~~                                                     ^~~~~~~~~~~~~~~~~~~~~~
                           %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:42:108: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
    printf ("%d %c, read = %ld, ref = %ld\n", split_ops[i].count, split_ops[i].op, split_ops[i].pos_query, split_ops[i].pos_ref);
                                      ~~~                                                                  ^~~~~~~~~~~~~~~~~~~~
                                      %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:49:48: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("read_pos = %ld -> ref_pos = %ld\n", read_pos, ref_pos);
                      ~~~                      ^~~~~~~~
                      %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:49:58: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("read_pos = %ld -> ref_pos = %ld\n", read_pos, ref_pos);
                                       ~~~               ^~~~~~~
                                       %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:53:48: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("read_pos = %ld -> ref_pos = %ld\n", read_pos, ref_pos);
                      ~~~                      ^~~~~~~~
                      %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:53:58: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("read_pos = %ld -> ref_pos = %ld\n", read_pos, ref_pos);
                                       ~~~               ^~~~~~~
                                       %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:57:48: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("read_pos = %ld -> ref_pos = %ld\n", read_pos, ref_pos);
                      ~~~                      ^~~~~~~~
                      %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:57:58: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("read_pos = %ld -> ref_pos = %ld\n", read_pos, ref_pos);
                                       ~~~               ^~~~~~~
                                       %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:62:48: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("ref_pos = %ld -> read_pos = %ld\n", ref_pos, read_pos);
                     ~~~                       ^~~~~~~
                     %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:62:57: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("ref_pos = %ld -> read_pos = %ld\n", ref_pos, read_pos);
                                       ~~~              ^~~~~~~~
                                       %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:66:48: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("ref_pos = %ld -> read_pos = %ld\n", ref_pos, read_pos);
                     ~~~                       ^~~~~~~
                     %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:66:57: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("ref_pos = %ld -> read_pos = %ld\n", ref_pos, read_pos);
                                       ~~~              ^~~~~~~~
                                       %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:70:48: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("ref_pos = %ld -> read_pos = %ld\n", ref_pos, read_pos);
                     ~~~                       ^~~~~~~
                     %lld
codebase/seqlib/src/sequences/sequence_alignment_test.cc:70:57: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  printf ("ref_pos = %ld -> read_pos = %ld\n", ref_pos, read_pos);
                                       ~~~              ^~~~~~~~
                                       %lld
14 warnings generated.
1 error generated.
make[1]: *** [obj_linux/codebase/gindex/src/minimizer_index/experimental.o] Error 1
1 error generated.
make[1]: *** [obj_linux/codebase/gindex/src/minimizer_index/minimizer_index.o] Error 1
codebase/argumentparser/src/argparser.cc:497:58: warning: format specifies type 'long *' but the argument has type 'int64_t *' (aka 'long long *') [-Wformat]
  sscanf(arguments_.at(it->second).value.c_str(), "%ld", value);
                                                   ~~~   ^~~~~
                                                   %lld
In file included from src/alignment/alignment.cc:8:
In file included from ./src/alignment/alignment.h:24:
In file included from ./src/containers/path_graph_entry.h:15:
In file included from ./src/containers/region.h:15:
In file included from codebase/gindex/src/minimizer_index/minimizer_index.h:11:
./src/sparsehash/dense_hash_map:106:10: fatal error: 'tr1/functional' file not found
#include HASH_FUN_H                 // for hash<>
         ^
./src/sparsehash/internal/sparseconfig.h:10:20: note: expanded from macro 'HASH_FUN_H'
#define HASH_FUN_H <tr1/functional>
                   ^
codebase/seqlib/src/sequences/sequence_file.cc:274:43: warning: format specifies type 'long' but the argument has type 'uint64_t' (aka 'unsigned long long') [-Wformat]
  fprintf (fp, "Current batch ID: %ld\n", current_batch_id_);
                                  ~~~     ^~~~~~~~~~~~~~~~~
                                  %llu
codebase/seqlib/src/sequences/sequence_file.cc:275:61: warning: format specifies type 'long' but the argument has type 'uint64_t' (aka 'unsigned long long') [-Wformat]
  fprintf (fp, "Current batch starting sequence ID: %ld\n", current_batch_starting_sequence_id_);
                                                    ~~~     ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
                                                    %llu
codebase/seqlib/src/sequences/single_sequence.cc:302:37: warning: format specifies type 'long' but the argument has type 'int64_t' (aka 'long long') [-Wformat]
  fprintf(fp, "Sequence ID: %ld\n", sequence_id_);
                            ~~~     ^~~~~~~~~~~~
                            %lld
1 warning generated.
2 warnings generated.
1 warning generated.
1 error generated.
make[1]: *** [obj_linux/src/alignment/alignment.o] Error 1
make: *** [tools/graphmap/bin/Linux-x64/graphmap] Error 2

Any suggestions are greatly appreciated.

racon seems to make no progress

Hi,

I'm trying to apply racon to a genome assembly draft ~ 900 Mbp generated using minimap2 as an overlapper and miniasm as the de novo assembler. I then used minimap2 to map the fastq back to the resultant assembly draft. The reads result from a sequel and so I've had to use the --bq -1 option. When I start the racon run the reads load successfully but then the output to the terminal with -v set to 9 is:

[23:27:06 ConsensusFromOverlaps] Started processing contig 1 / 16801 (0.01%): utg000001l
[23:27:06 ConsensusFromOverlaps] (thread_id = 0) Aligning overlaps for contig 1 / 16801 (0.01%): utg000001l
[23:27:15 AlignOverlaps] Aligning overlap: 2115 / 2116 (100.00%), skipped 0 / 2116 (0.00%)
[23:27:15 src/consensus/consensus_overlap.cc ConsensusFromOverlaps LN:144] CPU time spent on alignment: 9.69 sec.
[23:27:15 src/consensus/consensus_sam.cc CreateConsensusAln LN:277] current_contig->get_sequence_length() = 360527, parameters.window_len = 500, num_windows = 722
[23:27:15 src/consensus/consensus_sam.cc CreateConsensusAln LN:291] CPU time for building the IntervalTree: 0.020000 sec.
[23:27:15 CreateConsensusAln] (thread_id = 0) Processing window: 0 bp to 499 bp (0.00%)[23:27:15 src/consensus/consensus_sam.cc CreateConsensusAln LN:316] , clk_total_extract = 0.000000, clk_total_spoa =
[23:27:15 CreateConsensusAln] (thread_id = 0) Processing window: 500 bp to 999 bp (0.14%)[23:27:15 src/consensus/consensus_sam.cc CreateConsensusAln LN:316] , clk_total_extract = 0.000000, clk_total_spoa
= 0.000000, coverage: 4x

Left alone for a full day I've seen no additional progress and the consensus file is blank except for a single fasta header of the first sequence. I've tried running a version of racon built from github a few days ago as well as installed through bioconda with the same result. I'm only allowing a single thread presently and the program is only using about 20% of the memory the machine has. Are there any additional steps you might recommend for determining what might be going wrong? Thank you for your time and advice.

Exiting.In function: 'ParsePAF'

This is the error information:
#5: Unexpected value found! Overlaps are not formatted in the PAF format. Exiting.In function: 'ParsePAF'.

And my paf file looks like:
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/30/0_13974 13974 507 13859 + utg000001l 88984 24891 38334 2073 13443 255 cm:i:182
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/68/0_3300 3300 204 2272 + utg000697l 314885 115884 118067 145 2183 255 cm:i:12
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 22 3956 + utg000002l 43991 38915 42826 660 3934 255 cm:i:66
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 158 3980 + utg000003l 16020 9065 12833 666 3822 255 cm:i:56
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 115 3879 + utg002031l 46243 42607 46223 536 3764 255 cm:i:47
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 22 3879 + utg002471l 38305 2907 6571 452 3857 255 cm:i:41
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 158 3653 - utg002789l 20197 5756 9105 357 3495 255 cm:i:28
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 1373 3351 - utg000573l 96945 84380 86308 165 1978 255 cm:i:16
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 2462 3358 - utg001664l 52850 1969 2871 58 902 255 cm:i:7
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 695 1039 + utg002221l 63915 21629 21945 64 344 255 cm:i:6
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 669 892 - utg000531l 192555 100182 100380 49 223 255 cm:i:5
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/163/0_4021 4021 732 890 - utg002451l 79420 30732 30873 47 158 255 cm:i:4
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/194/0_5043 5043 503 4875 - utg000004l 55874 37728 50373 557 12645 255 cm:i:50
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/194/0_5043 5043 460 5041 - utg002719l 29432 101 5867 496 5766 255 cm:i:45
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/194/0_5043 5043 387 5016 - utg000005l 35283 160 7127 424 6967 255 cm:i:38
m170110_073744_42228_c101136512550000001823249906131712_s1_p0/194/0_5043 5043 283 2987 + utg000004l 55874 37699 45545 278 7846 255 cm:i:26

Racon gets killed

Hi!

I used Racon in the past and it run perfectly, but now I am running it with more nanopore data and I am running into trouble.
My nanopore reads (FASTQ) is 56.7Gb and my assembled genome is 887Mb.
I first runned Graphmap:
./graphmap/bin/Linux-x64/graphmap align -r assembled_genome_albacore_v2.fasta -d nanopore_reads_albacore_v2.fastq -o assembled_genom_nanopore_reads_albacore_v2.sam;
This generated a 75.7Gb sam file. Then I runned Racon with the following command:
/home/nextgen/racon/bin/racon --sam nanopore_reads_albacore_v2.fastq assembled_genom_nanopore_reads_albacore_v2.sam assembled_genome_albacore_v2.fasta assembled_genome_albacore_v2_Racon.fasta
But after 10-15 minutes, when is Parsin the Sam file, the process gets killed:
[07:08:38 main] Using SAM for input alignments. (assembled_genom_nanopore_reads_albacore_v2.sam)
[07:08:38 main] Parsing the SAM file.
Killed

Can this be due to the RAM memory? How can I chek that?
Thanks!

Elena

Output file blank/script ends abruptly

Hi there,

I'm having a problem with using racon. The racon script appears to end abruptly during consensus building and the output file is blank. I'm not sure what the problem is as all the intermediate steps seemed to work fine and I can't find any error messages or logs. Does anyone have any ideas?

Thanks,

Tim


#creation of raw contigs using minimap/miniasm

minimap -Sw5 -L100 -m0 -t8 BC01.fastq BC01.fastq | gzip -1 > BC01_reads.paf.gz

miniasm -f BC01.fastq BC01_reads.paf.gz > BC01_miniasm_assembly.gfa

#mapping of raw contigs and reads

minimap BC01_miniasm_assembly.gfa BC01.fastq > BC01_mappings_1.paf

#consensus building with racon

./racon/bin/racon BC01.fastq BC01_mappings_1.paf BC01_miniasm_assembly.gfa BC01_racon_consensus_1.fasta

[11:50:52 main] Using PAF for input alignments. (BC01_mappings_1.paf)
[11:50:52 main] Loading reads.
[11:51:03 main] Hashing qnames.
[11:51:04 main] Parsing the overlaps file.
[11:51:04 main] Unique overlaps will be filtered on the fly.
[11:51:04 main] Overlaps will be fully aligned.
[11:51:04 ConsensusFromOverlaps] Running consensus.
[11:51:04 ConsensusFromOverlaps] Separating overlaps to individual contigs.
[11:51:04 ConsensusFromOverlaps] In total, there are 1 contigs for consensus, each containing:
[11:51:04 ConsensusFromOverlaps] [0] utg000001l 0 alignments, contig len: 10329378

[11:51:04 ConsensusFromOverlaps] Started processing contig 1 / 1 (100.00%): utg000001l

/usr/bin/time and dnadiff not found

After compilation, I tried running the ./example1_1-paf-lambda-align.sh script, but it's failing because it assumes /usr/bin/time and dnadiff are present. These are not mentioned as prerequisites.

Based on #19, dnadiff should be created by the make commands at the beginning of the script, but this shouldn't be necessary if the installation instructions were followed and worked.

The installation instructions should also include which paths should be added to the user's PATH, other than $PREFIX/bin

-qv or -bq in the README?

Hi,

In the README it says:

"There is also a default QV threshold set to 10 (Phred score). If your data is of poorer quality, you can modify this parameter using --qv FLOAT"

I think this should be -bq FLOAT?

Make creates lots of prcessors and overloads server, which kills compilation

I am trying to compile racon.

make modules finishes fine.

I then tried "make tools" and got lots of "out of memory errors" and:

g++: internal compiler error: Killed (program cc1plus)

So then I tried:

make -j 1 tools

This should limit the jobs to 1; however, look at the attached screenshot -
raconwut

What the....?

Compilation is being killed by the OS

How do I fix this?

Cheers
Mick

Racon for consensus then error correcting

Hi,
Sorry to bother you again, but I have a question about Racon's suggested use.
First, off I took a mammalian de novo assembly (Illumina short-insert [500bp] and long-insert [5kbp] reads) and filled in gaps with 10x coverage PacBio Sequel reads with PBJelly. Then I mapped the PacBio reads to the PBJelly assembly and created a consensus with Racon (using --bq -1). Now I would like to error correct the Racon assembly with the original Illumina short-insert reads used for the de novo assembly (will not include the mate-pair reads), but Pilon seems very slow for this purpose considering this is a 2Gbp genome [Right now we are trying to split up the genome into chunks to see how well that Pilon performs in that regard]. Does it seem reasonable to use minimap2 to overlap the Illumina short-insert reads into a PAF and then run Racon in error correct mode? Note that I am using commit 0834442 on the master branch.

Stuck at first consensus window

Hi.
I am running Racon with a ~45 Mb Miniasm assembly purely from ONT reads. I aligned the reads (2D Pass only) with GraphMap. I first tried Racon with default parameters and I got the same input reference as output, without changes. Then I removed the quality filtering to check if it was the problem and it seems it was, because now it finds the alignments. However, it has been stuck on the first processing window for two days now, and looking at your poster from London Calling and by common sense, it should be way past there. But the process seems to be still running, as it shows so when doing 'top'.
This is the line where its stuck:
[13:58:42 CreateConsensus] (thread_id = 0) Processing window: 0 bp to 499 bp (0.00%), coverage: 8x

And this is the command:
racon -t 8 --bq -1 miniasm.fasta 2d.miniasm.sam miniasm.racon.fasta

2 correction steps

Hi,
Are the following commands correct set up for 2 correction steps?

minimap -Sw5 -L100 -m0 \
        -t 18 \
        /work/lorencm/All_RawData/RSnSeQ_110Fruit.fastq \
        /work/lorencm/All_RawData/RSnSeQ_110Fruit.fastq \
        | gzip -1 > Fruit.paf.gz


miniasm -f /work/lorencm/All_RawData/RSnSeQ_110Fruit.fastq \
        Fruit.paf.gz \
        > Fruit.gfa

awk '{print ">"$2; print $3}' Fruit | fold  Fruit.gfa.fasta

# Correction 1

minimap Fruit.gfa.fasta \
        /work/lorencm/All_RawData/RSnSeQ_110Fruit.fastq \
        > Fruit.gfa1.paf

racon -t 18 \
        /work/lorencm/All_RawData/RSnSeQ_110Fruit.fastq \
        Fruit.gfa1.paf \
        Fruit.gfa.fasta \
        Fruit.racon1.fasta

# Correction 2

minimap Fruit.racon1.fasta \
        /work/lorencm/All_RawData/RSnSeQ_110Fruit.fastq \
        > Fruit.gfa2.paf

racon -t 18 \
        /work/lorencm/All_RawData/RSnSeQ_110Fruit.fastq \
        Fruit.gfa2.paf \
        Fruit.racon1.fasta \
        Fruit.racon2.fasta

Thank you in advance.

Michal

Illegal instructions error.

Hi, this is the first time I use Racon, and keep on getting these error when trying to run the command.

ubuntu@biolinux:/mnt/Federico/TD_4$ racon '/mnt/Federico/TD_2/trimmedpass.fastq' '/mnt/Federico/TD_4/mappings.paf' '/mnt/Federico/TD_4/smartdenovoTD1.fasta' racon1.fasta 
Illegal instructions.

I build racon using bioconda, so I guess the installation is ok?

Any ideas?

Thanks.

racon

Hi,
I am trying to manually implement to this pipeline.
https://github.com/nanoporetech/ont-assembly-polish/blob/master/analysis.mk

So I follow,

  1. canu assembly with my pacbio reads
  2. map those pacbio reads to contigs (from canu) with minimap.
  3. polish them with racon.

In the third step, I am having a problem with inputting paf file generated from minimap. I dont see why I am having this problem because when I compre this format with the format which worked fine with racon are same.

This is the racon command line options that I use.

racon -t 16 -v 9 ~/kefal_genome_miniasm/kefal_pacbio_bigfile_fastq  ~/asemmbly_polish_with_illumina/manuelRun/minimap_1/minimap_overlaps.paf ./kefal.contigs.fa racon_correct_reads.fasta

This is the error that I get.

tmorova@lisa:~/asemmbly_polish_with_illumina/manuelRun/racon_1$ sh step2.sh
[17:51:47 main] Using PAF for input alignments. (/home/tmorova/asemmbly_polish_with_illumina/manuelRun/minimap_1/minimap_overlaps.paf)
[17:51:47 main] Loading reads.
[Mon, 18 Dec 17 14:51:47 +0000 FATAL] #5: Unexpected value found! Input sequence file format unknown!
 In function: 'LoadSeqs_'.
tmorova@lisa:~/asemmbly_polish_with_illumina/manuelRun/minimap_1$ head minimap_overlaps.paf
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/31178_33504        2326    1281    2295    +       tig00019057     21572   9601    10513   162     1014    255     cm:i:17
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/33550_41136        7586    22      7432    -       tig00019057     21572   3075    10519   1895    7444    255     cm:i:209
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/33550_41136        7586    3817    5093    -       tig00014190     65533   24660   25896   301     1276    255     cm:i:31
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/33550_41136        7586    3817    5093    +       tig00021301     57956   29305   30561   295     1276    255     cm:i:27
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/33550_41136        7586    3965    5101    +       tig00004520     176768  89077   90177   257     1136    255     cm:i:26
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/33550_41136        7586    3817    5101    +       tig00058750     42190   33242   34469   255     1284    255     cm:i:26
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/33550_41136        7586    3817    5101    -       tig00563576     282163  35986   37227   247     1284    255     cm:i:25
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/33550_41136        7586    3817    5101    +       tig00034468     19268   9739    10987   245     1284    255     cm:i:25
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/33550_41136        7586    3817    5101    +       tig00007629     87413   52356   53618   262     1284    255     cm:i:25
m161115_082159_42163R_c101134722550000001823248606131762_s1_p0/54494/33550_41136        7586    3817    5093    +       tig00019376     45335   34915   36486   234     1571    255     cm:i:24
tmorova@lisa:~/asemmbly_polish_with_illumina/manuelRun/minimap_1$ tail minimap_overlaps.paf
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   10182   10278   +       tig00000810     192408  22289   22384   51      96      255     cm:i:4
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   1782    1832    -       tig00061924     82566   39570   39619   42      50      255     cm:i:4
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   1351    2207    -       tig00020221     54784   13520   14369   41      856     255     cm:i:4
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   9615    9812    -       tig00562182     10189   9654    9855    47      201     255     cm:i:4
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   10182   10278   +       tig00000658     318007  251916  252011  51      96      255     cm:i:4
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   4601    5789    -       tig00004438     118089  9897    10939   46      1188    255     cm:i:4
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   10182   10278   -       tig00004224     72862   41597   41692   51      96      255     cm:i:4
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   10182   10278   -       tig00058734     74269   56652   56746   51      96      255     cm:i:4
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   10182   10278   +       tig00000296     80234   20586   20681   51      96      255     cm:i:4
m160720_100353_42163R_c101033082550000001823255011171637_s1_p0/108987/0_12784   12784   10182   10278   -       tig00560706     30583   7472    7567    51      96      255     cm:i:4

I suspect that the way that I ran canu could be a problem. In canu, instead of giving a single big fastq, I gave the file directory with *.fastq so it combined them automatically in the system. Could this be the reason of the difference ? should I run my canu with a single big fastq file input ?

I would be more than happy if you could help me out with my problem,

Best regards,

tunc.

ERROR] #5: Could not find qname 'blah-blah' in the input contigs file!

Hi there !

It's the first time I use racon and I encounter this error message:
"ERROR] #5: Unexpected value found! Could not find qname '645a46de-26ef-41ac-8006-7d49097c69c4' in the input contigs file! Exiting. In function: 'ParsePAF"
I saw that there was a previous post open on a similar issue. Thus, I took a look at my .paf format which is fine I think.
It seems that racon complains that the read in question is not in the .gfa. I checked this and indeed it is not included in it while it figures in the .paf. My guess is that is not included in the .gfa because it wasn't use to build the final contigs and fell off the assembly.

Thus, I feel I am missing something here. Does racon necessitate the usage of an option in miniasm that would output the unused reads in the .gfa ? If it does, I wasn't able to find it.
I am sure this will sound very candide question. Sorry for that...

Thank you !

AL

Recommend Projects

  • React photo React

    A declarative, efficient, and flexible JavaScript library for building user interfaces.

  • Vue.js photo Vue.js

    ๐Ÿ–– Vue.js is a progressive, incrementally-adoptable JavaScript framework for building UI on the web.

  • Typescript photo Typescript

    TypeScript is a superset of JavaScript that compiles to clean JavaScript output.

  • TensorFlow photo TensorFlow

    An Open Source Machine Learning Framework for Everyone

  • Django photo Django

    The Web framework for perfectionists with deadlines.

  • D3 photo D3

    Bring data to life with SVG, Canvas and HTML. ๐Ÿ“Š๐Ÿ“ˆ๐ŸŽ‰

Recommend Topics

  • javascript

    JavaScript (JS) is a lightweight interpreted programming language with first-class functions.

  • web

    Some thing interesting about web. New door for the world.

  • server

    A server is a program made to process requests and deliver data to clients.

  • Machine learning

    Machine learning is a way of modeling and interpreting data that allows a piece of software to respond intelligently.

  • Game

    Some thing interesting about game, make everyone happy.

Recommend Org

  • Facebook photo Facebook

    We are working to build community through open source technology. NB: members must have two-factor auth.

  • Microsoft photo Microsoft

    Open source projects and samples from Microsoft.

  • Google photo Google

    Google โค๏ธ Open Source for everyone.

  • D3 photo D3

    Data-Driven Documents codes.