diff --git a/Cecret.nf b/Cecret.nf index 3f6a1c9..abcee4e 100644 --- a/Cecret.nf +++ b/Cecret.nf @@ -3,7 +3,7 @@ println("Currently using the Cecret workflow for use with amplicon-based Illumina hybrid library prep on MiSeq\n") println("Author: Erin Young") println("email: eriny@utah.gov") -println("Version: v.2.3.20220114") +println("Version: v.2.4.20220407") println("") params.reads = workflow.launchDir + '/reads' @@ -116,6 +116,8 @@ params.bamsnap = false // can be really slow params.rename = false params.filter = false params.vadr = true +params.freyja = true +params.multiqc = true // for optional contamination determination params.kraken2 = false @@ -142,7 +144,7 @@ if ( params.maxcpus < 5 ) { // This is where the results will be println("The files and directory for results is " + params.outdir) -println("A table summarizing results will be created: ${params.outdir}/summary.txt and ${workflow.launchDir}/cecret_run_results.txt\n") +println("A table summarizing results will be created: ${params.outdir}/cecret_results.csv\n") Channel .fromPath(params.reference_genome, type:'file') @@ -197,6 +199,7 @@ process fastqc { output: file("${task.process}/*.{html,zip}") + file("${task.process}/*_fastqc.zip") into fastqc_files tuple sample, env(raw_1) into fastqc_1_results tuple sample, env(raw_2) into fastqc_2_results file("logs/${task.process}/${sample}.${workflow.sessionId}.{log,err}") @@ -248,7 +251,7 @@ if ( params.cleaner == 'seqyclean' ) { tuple sample, file("${task.process}/${sample}_cln_SE.fastq.gz") optional true into single_files tuple sample, file("${task.process}/${sample}_clean_PE{1,2}.fastq.gz"), val(paired_single) optional true into paired_files_kraken2 tuple sample, file("${task.process}/${sample}_cln_SE.fastq.gz"), val(paired_single) optional true into single_files_kraken2 - file("${task.process}/${sample}_cl*n_SummaryStatistics.tsv") into seqyclean_files + file("${task.process}/${sample}_cl*n_SummaryStatistics.tsv") into seqyclean_files, seqyclean_files_collect file("${task.process}/${sample}_cl*n_SummaryStatistics.txt") file("logs/${task.process}/${sample}.${workflow.sessionId}.{log,err}") tuple sample, env(perc_kept) into seqyclean_perc_kept_results @@ -296,8 +299,9 @@ if ( params.cleaner == 'seqyclean' ) { } fastp_results=Channel.empty() + fastp_files=Channel.empty() - seqyclean_files + seqyclean_files_collect .collectFile(name: "Combined_SummaryStatistics.tsv", keepHeader: true, sort: true, @@ -322,7 +326,8 @@ if ( params.cleaner == 'seqyclean' ) { tuple sample, file("${task.process}/${sample}_cln.fastq.gz") optional true into single_files tuple sample, file("${task.process}/${sample}_clean_PE{1,2}.fastq.gz"), val(paired_single) optional true into paired_files_kraken2 tuple sample, file("${task.process}/${sample}_cln.fastq.gz"), val(paired_single) optional true into single_files_kraken2 - file("${task.process}/${sample}_fastp.{html,json}") + file("${task.process}/${sample}_fastp.html") + file("${task.process}/${sample}_fastp.json") into fastp_files file("logs/${task.process}/${sample}.${workflow.sessionId}.{log,err}") tuple sample, env(passed_reads) into fastp_results tuple sample, env(cleaner_version) into cleaner_version @@ -363,6 +368,7 @@ if ( params.cleaner == 'seqyclean' ) { } seqyclean_perc_kept_results=Channel.empty() seqyclean_pairskept_results=Channel.empty() + seqyclean_files=Channel.empty() } if (params.aligner == 'bwa') { @@ -517,6 +523,7 @@ if (params.trimmer == 'ivar' ) { tuple sample, file("${task.process}/${sample}.primertrim.sorted.bam") into trimmed_bams, trimmed_bams4, trimmed_bams5 tuple sample, file("${task.process}/${sample}.primertrim.sorted.bam"), file("ivar_trim/${sample}.primertrim.sorted.bam.bai") into bam_bai file("logs/${task.process}/${sample}.${workflow.sessionId}.{log,err}") + file("${task.process}/${sample}_ivar.log") into ivar_trim_files tuple sample, env(trimmer_version) into trimmer_version shell: @@ -533,6 +540,8 @@ if (params.trimmer == 'ivar' ) { # trimming the reads ivar trim !{params.ivar_trim_options} -e -i !{bam} -b !{primer_bed} -p !{task.process}/!{sample}.primertrim 2>> $err_file >> $log_file + grep "Found" -A 10000 $log_file | grep -A 10000 "primers in BED file" > !{task.process}/!{sample}_ivar.log + # sorting and indexing the trimmed bams samtools sort !{task.process}/!{sample}.primertrim.bam -o !{task.process}/!{sample}.primertrim.sorted.bam 2>> $err_file >> $log_file samtools index !{task.process}/!{sample}.primertrim.sorted.bam 2>> $err_file >> $log_file @@ -575,9 +584,12 @@ if (params.trimmer == 'ivar' ) { samtools index !{task.process}/!{sample}.primertrim.sorted.bam 2>> $err_file >> $log_file ''' } + ivar_trim_files=Channel.empty() + } else if (params.trimmer == 'none') { trimmer_version=Channel.empty() trimmed_bams4=Channel.empty() + ivar_trim_files=Channel.empty() pre_trim_bams .into { trimmed_bams ; trimmed_bams5 } pre_trim_bams_bedtools @@ -586,7 +598,7 @@ if (params.trimmer == 'ivar' ) { trimmed_bams .combine(reference_genome2) - .into { trimmed_bams_genome ; trimmed_bams_ivar_consensus ; trimmed_bams_bcftools_variants } + .into { trimmed_bams_genome ; trimmed_bams_ivar_consensus ; trimmed_bams_bcftools_variants ; trimmed_bams_freyja } params.minimum_depth = 100 params.mpileup_depth = 8000 @@ -873,31 +885,31 @@ process samtools_stats { tuple val(sample), file(aligned), file(trimmed) from pre_post_bams output: - file("${task.process}/aligned/${sample}.stats.txt") - file("${task.process}/trimmed/${sample}.stats.trim.txt") optional true + file("${task.process}/${sample}.stats.{aligned,trimmed}.txt") + file("${task.process}/${sample}.stats.txt") optional true into samtools_stats_files tuple sample, env(insert_size_before_trimming) into samtools_stats_before_size_results tuple sample, env(insert_size_after_trimming) into samtools_stats_after_size_results file("logs/${task.process}/${sample}.${workflow.sessionId}.{log,err}") shell: ''' - mkdir -p !{task.process}/aligned !{task.process}/trimmed logs/!{task.process} + mkdir -p !{task.process} logs/!{task.process} log_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.log err_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.err date | tee -a $log_file $err_file > /dev/null samtools --version >> $log_file - samtools stats !{params.samtools_stats_options} !{aligned} 2>> $err_file > !{task.process}/aligned/!{sample}.stats.txt + samtools stats !{params.samtools_stats_options} !{aligned} 2>> $err_file | tee !{task.process}/!{sample}.stats.aligned.txt !{task.process}/!{sample}.stats.txt + insert_size_before_trimming=$(grep "insert size average" !{task.process}/!{sample}.stats.txt | cut -f 3) if [ "!{trimmed}" == "null" ] || [[ "!{trimmed}" == *"input"* ]] then insert_size_after_trimming="NA" else - samtools stats !{params.samtools_stats_options} !{trimmed} 2>> $err_file > !{task.process}/trimmed/!{sample}.stats.trim.txt - insert_size_after_trimming=$(grep "insert size average" !{task.process}/trimmed/!{sample}.stats.trim.txt | cut -f 3) + samtools stats !{params.samtools_stats_options} !{trimmed} 2>> $err_file | tee !{task.process}/!{sample}.stats.trimmed.txt !{task.process}/!{sample}.stats.txt + insert_size_after_trimming=$(grep "insert size average" !{task.process}/!{sample}.stats.trimmed.txt | cut -f 3) fi - insert_size_before_trimming=$(grep "insert size average" !{task.process}/aligned/!{sample}.stats.txt | cut -f 3) if [ -z "$insert_size_before_trimming" ] ; then insert_size_before_trimming=0 ; fi if [ -z "$insert_size_after_trimming" ] ; then insert_size_after_trimming=0 ; fi @@ -918,32 +930,32 @@ process samtools_coverage { tuple val(sample), file(aligned), file(trimmed) from pre_post_bams2 output: - file("${task.process}/{aligned,trimmed}/${sample}.cov.{txt,hist}") optional true + file("${task.process}/${sample}.cov.{aligned,trimmed}.{txt,hist}") optional true file("logs/${task.process}/${sample}.${workflow.sessionId}.{log,err}") tuple sample, env(coverage) into samtools_coverage_results tuple sample, env(depth) into samtools_covdepth_results shell: ''' - mkdir -p !{task.process}/aligned !{task.process}/trimmed logs/!{task.process} + mkdir -p !{task.process} logs/!{task.process} log_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.log err_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.err date | tee -a $log_file $err_file > /dev/null samtools --version >> $log_file - samtools coverage !{params.samtools_coverage_options} !{aligned} -m -o !{task.process}/aligned/!{sample}.cov.hist 2>> $err_file >> $log_file - samtools coverage !{params.samtools_coverage_options} !{aligned} -o !{task.process}/aligned/!{sample}.cov.txt 2>> $err_file >> $log_file + samtools coverage !{params.samtools_coverage_options} !{aligned} -m -o !{task.process}/!{sample}.cov.aligned.hist 2>> $err_file >> $log_file + samtools coverage !{params.samtools_coverage_options} !{aligned} -o !{task.process}/!{sample}.cov.aligned.txt 2>> $err_file >> $log_file if [ "!{trimmed}" == "null" ] || [[ "!{trimmed}" == *"input"* ]] then - coverage=$(cut -f 6 !{task.process}/aligned/!{sample}.cov.trim.txt | tail -n 1) - depth=$(cut -f 7 !{task.process}/aligned/!{sample}.cov.trim.txt | tail -n 1) + coverage=$(cut -f 6 !{task.process}/!{sample}.cov.aligned.txt | tail -n 1) + depth=$(cut -f 7 !{task.process}/!{sample}.cov.aligned.txt | tail -n 1) else - samtools coverage !{params.samtools_coverage_options} !{trimmed} -m -o !{task.process}/trimmed/!{sample}.cov.trim.hist 2>> $err_file >> $log_file - samtools coverage !{params.samtools_coverage_options} !{trimmed} -o !{task.process}/trimmed/!{sample}.cov.trim.txt 2>> $err_file >> $log_file - coverage=$(cut -f 6 !{task.process}/trimmed/!{sample}.cov.trim.txt | tail -n 1) - depth=$(cut -f 7 !{task.process}/trimmed/!{sample}.cov.trim.txt | tail -n 1) + samtools coverage !{params.samtools_coverage_options} !{trimmed} -m -o !{task.process}/!{sample}.cov.trimmed.hist 2>> $err_file >> $log_file + samtools coverage !{params.samtools_coverage_options} !{trimmed} -o !{task.process}/!{sample}.cov.trimmed.txt 2>> $err_file >> $log_file + coverage=$(cut -f 6 !{task.process}/!{sample}.cov.trimmed.txt | tail -n 1) + depth=$(cut -f 7 !{task.process}/!{sample}.cov.trimmed.txt | tail -n 1) fi if [ -z "$coverage" ] ; then coverage="0" ; fi @@ -965,12 +977,13 @@ process samtools_flagstat { params.samtools_flagstat output: - file("${task.process}/{aligned,trimmed}/${sample}.flagstat.txt") optional true + file("${task.process}/${sample}.flagstat.{aligned,trimmed}.txt") optional true + file("${task.process}/${sample}.flagstat.txt") optional true into samtools_flagstat_files file("logs/${task.process}/${sample}.${workflow.sessionId}.{log,err}") shell: ''' - mkdir -p !{task.process}/aligned !{task.process}/trimmed logs/!{task.process} + mkdir -p !{task.process} logs/!{task.process} log_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.log err_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.err @@ -979,7 +992,7 @@ process samtools_flagstat { samtools flagstat !{params.samtools_flagstat_options} \ !{aligned} \ - 2>> $err_file > !{task.process}/aligned/!{sample}.flagstat.txt + 2>> $err_file | tee !{task.process}/!{sample}.flagstat.aligned.txt !{task.process}/!{sample}.flagstat.txt if [ "!{trimmed}" == "null" ] || [[ "!{trimmed}" == *"input"* ]] then @@ -987,7 +1000,7 @@ process samtools_flagstat { else samtools flagstat !{params.samtools_flagstat_options} \ !{trimmed} \ - 2>> $err_file > !{task.process}/trimmed/!{sample}.flagstat.txt + 2>> $err_file | tee !{task.process}/!{sample}.flagstat.trimmed.txt !{task.process}/!{sample}.flagstat.txt fi ''' } @@ -1006,13 +1019,13 @@ process samtools_depth { params.samtools_depth output: - file("${task.process}/{aligned,trimmed}/${sample}.depth.txt") optional true + file("${task.process}/${sample}.depth.{aligned,trimmed}.txt") optional true tuple sample, env(depth) into samtools_depth_results file("logs/${task.process}/${sample}.${workflow.sessionId}.{log,err}") shell: ''' - mkdir -p !{task.process}/aligned !{task.process}/trimmed logs/!{task.process} + mkdir -p !{task.process} logs/!{task.process} log_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.log err_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.err @@ -1021,16 +1034,16 @@ process samtools_depth { samtools depth !{params.samtools_depth_options} \ !{aligned} \ - 2>> $err_file > !{task.process}/aligned/!{sample}.depth.txt + 2>> $err_file > !{task.process}/!{sample}.depth.aligned.txt if [ "!{trimmed}" == "null" ] || [[ "!{trimmed}" == *"input"* ]] then - depth=$(awk '{ if ($3 > !{params.minimum_depth} ) print $0 }' !{task.process}/aligned/!{sample}.depth.txt | wc -l ) + depth=$(awk '{ if ($3 > !{params.minimum_depth} ) print $0 }' !{task.process}/!{sample}.depth.aligned.txt | wc -l ) else samtools depth !{params.samtools_depth_options} \ !{trimmed} \ - 2>> $err_file > !{task.process}/trimmed/!{sample}.depth.txt - depth=$(awk '{ if ($3 > !{params.minimum_depth} ) print $0 }' !{task.process}/trimmed/!{sample}.depth.txt | wc -l ) + 2>> $err_file > !{task.process}/!{sample}.depth.trimmed.txt + depth=$(awk '{ if ($3 > !{params.minimum_depth} ) print $0 }' !{task.process}/!{sample}.depth.trimmed.txt | wc -l ) fi if [ -z "$depth" ] ; then depth="0" ; fi @@ -1051,7 +1064,7 @@ process kraken2 { tuple val(sample), file(clean), val(paired_single), path(kraken2_db) from paired_files_kraken2.concat(single_files_kraken2).combine(kraken2_db) output: - file("${task.process}/${sample}_kraken2_report.txt") + file("${task.process}/${sample}_kraken2_report.txt") into kraken2_files file("logs/${task.process}/${sample}.${workflow.sessionId}.{log,err}") tuple sample, env(percentage_cov) into kraken2_sars_results tuple sample, env(percentage_human) into kraken2_human_results @@ -1222,7 +1235,7 @@ process pangolin { output: file("${task.process}/*") - file("${task.process}/lineage_report.csv") into pangolin_file + file("${task.process}/lineage_report.csv") into pangolin_file, pangolin_files file("logs/${task.process}/${task.process}.${workflow.sessionId}.{log,err}") shell: @@ -1355,6 +1368,100 @@ process vadr { ''' } +if (params.freyja) { + params.freyja_variants_options='' + params.freyja_demix_options='' + params.freyja_boot_options='--nb 1000' + process freyja { + publishDir "${params.outdir}", mode: 'copy' + tag "${sample}" + cpus params.medcpus + container 'staphb/freyja:latest' + errorStrategy 'ignore' + + input: + tuple val(sample), file(bam), file(reference_genome) from trimmed_bams_freyja + + output: + file("${task.process}/${sample}_demix.tsv") into freyja_demix + file("${task.process}/${sample}*") + file("logs/${task.process}/${sample}.${workflow.sessionId}.{err,log}") + + shell: + ''' + mkdir -p !{task.process} logs/!{task.process} + log_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.log + err_file=logs/!{task.process}/!{sample}.!{workflow.sessionId}.err + + date | tee -a $log_file $err_file > /dev/null + # no version for 1.3.4 + + freyja variants !{params.freyja_variants_options} \ + !{bam} \ + --variants !{task.process}/!{sample}_variants.tsv \ + --depths !{task.process}/!{sample}_depths.tsv \ + --ref !{reference_genome} \ + 2>> $err_file >> $log_file + + # freyja update 2>> $err_file >> $log_file + + freyja demix \ + !{params.freyja_demix_options} \ + !{task.process}/!{sample}_variants.tsv \ + !{task.process}/!{sample}_depths.tsv \ + --output !{task.process}/!{sample}_demix.tsv \ + 2>> $err_file >> $log_file + + freyja boot \ + !{task.process}/!{sample}_variants.tsv \ + !{task.process}/!{sample}_depths.tsv \ + --nt !{task.cpus} \ + --output_base !{task.process}/!{sample}_boot.tsv \ + 2>> $err_file >> $log_file + ''' + } + params.freyja_aggregate_options='' + params.freyja_plot_options='' + params.freyja_plot_filetype='png' + process freyja_aggregate { + publishDir "${params.outdir}", mode: 'copy' + tag "Aggregating results from freyja" + cpus 1 + container 'staphb/freyja:latest' + + input: + file(demix) from freyja_demix.collect() + + output: + file("freyja/aggregated*") + file("freyja/aggregated-freyja.tsv") into aggregated_freyja_file + file("logs/${task.process}/${task.process}.${workflow.sessionId}.{err,log}") + + shell: + ''' + mkdir -p freyja logs/!{task.process} tmp + log_file=logs/!{task.process}/!{task.process}.!{workflow.sessionId}.log + err_file=logs/!{task.process}/!{task.process}.!{workflow.sessionId}.err + + date | tee -a $log_file $err_file > /dev/null + + mv !{demix} tmp/. + + freyja aggregate !{params.freyja_aggregate_options} \ + tmp/ \ + --output freyja/aggregated-freyja.tsv \ + 2>> $err_file >> $log_file + + freyja plot !{params.freyja_plot_options} \ + freyja/aggregated-freyja.tsv \ + --output freyja/aggregated-freyja.!{params.freyja_plot_filetype} \ + 2>> $err_file >> $log_file + ''' + } +} else { + aggregated_freyja_file = Channel.empty() +} + consensus_results .concat(fastas_results) .join(fastqc_1_results, remainder: true, by: 0) @@ -1523,6 +1630,7 @@ process combine_results { file(nextclade) from nextclade_file.ifEmpty([]) file(pangolin) from pangolin_file.ifEmpty([]) file(vadr) from vadr_file.ifEmpty([]) + file(freyja) from aggregated_freyja_file.ifEmpty([]) file(summary) from summary_file.collect() file(combine_results) from combine_results_script @@ -1770,6 +1878,48 @@ if (params.rename) { } } +params.multiqc_options = '' +process multiqc { + publishDir "${params.outdir}", mode: 'copy' + tag "multiqc" + cpus 1 + container 'ewels/multiqc:latest' + + when: + params.multiqc + + input: + file(fastqc) from fastqc_files.collect().ifEmpty([]) + file(fastp) from fastp_files.collect().ifEmpty([]) + file(seqyclean) from seqyclean_files.collect().ifEmpty([]) + file(kraken2) from kraken2_files.collect().ifEmpty([]) + file(pangolin) from pangolin_files.collect().ifEmpty([]) + file(ivar) from ivar_trim_files.collect().ifEmpty([]) + file(samtools_stats) from samtools_stats_files.collect().ifEmpty([]) + file(samtools_flagstat) from samtools_flagstat_files.collect().ifEmpty([]) + + output: + file("${task.process}/multiqc_report.html") optional true + file("${task.process}/multiqc_data/*") optional true + file("logs/${task.process}/${task.process}.${workflow.sessionId}.{log,err}") + + shell: + ''' + mkdir -p !{task.process} logs/!{task.process} + log_file=logs/!{task.process}/!{task.process}.!{workflow.sessionId}.log + err_file=logs/!{task.process}/!{task.process}.!{workflow.sessionId}.err + + # time stamp + capturing tool versions + date | tee -a $log_file $err_file > /dev/null + multiqc --version >> $log_file + + multiqc !{params.multiqc_options} \ + --outdir !{task.process} \ + . \ + 2>> $err_file >> $log_file + ''' +} + if (params.nextclade || params.nextclade || params.nextclade) { workflow.onComplete { println("Pipeline completed at: $workflow.complete") @@ -1780,7 +1930,7 @@ if (params.nextclade || params.nextclade || params.nextclade) { } else { workflow.onComplete { println("Pipeline completed at: $workflow.complete") - println("A summary of results can be found in a comma-delimited file: ${params.outdir}/summary.csv") + println("A summary of results can be found in a comma-delimited file: ${params.outdir}/summary/combined_summary.csv") println("Execution status: ${ workflow.success ? 'OK' : 'failed' }") } } diff --git a/README.md b/README.md index d644ba8..35be061 100644 --- a/README.md +++ b/README.md @@ -8,7 +8,7 @@ Location: 40.570°N 111.622°W , 9,875 feet (3,010 m) elevation Cecret is a workflow developed by [@erinyoung](https://github.com/erinyoung) at the [Utah Public Health Laborotory](https://uphl.utah.gov/) for SARS-COV-2 sequencing with the [artic](https://artic.network/ncov-2019/ncov2019-bioinformatics-sop.html)/Illumina hybrid library prep workflow for MiSeq data with protocols [here](https://www.protocols.io/view/sars-cov-2-sequencing-on-illumina-miseq-using-arti-bffyjjpw) and [here](https://www.protocols.io/view/sars-cov-2-sequencing-on-illumina-miseq-using-arti-bfefjjbn). Built to work on linux-based operating systems. Additional config options are needed for cloud batch usage. -It is possible to use this workflow to simply annotate fastas generated from any workflow with pangolin, nextclade, and vadr. Another utility is to find consensus fasta files from fastq files, and add in fasta files that were generated previously or downloaded from [GISAID](https://www.gisaid.org/) or [NCBI](https://www.ncbi.nlm.nih.gov/sars-cov-2/) for multiple sequence alignment (MSA) and phylogenetic tree creation. +It is possible to use this workflow to simply annotate fastas generated from any workflow with pangolin, nextclade, freyja, and vadr. Another utility is to find consensus fasta files from fastq files, and add in fasta files that were generated previously or downloaded from [GISAID](https://www.gisaid.org/) or [NCBI](https://www.ncbi.nlm.nih.gov/sars-cov-2/) for multiple sequence alignment (MSA) and phylogenetic tree creation. Cecret is also part of the [staphb-toolkit](https://github.com/StaPH-B/staphb_toolkit). @@ -40,10 +40,10 @@ nextflow run Cecret.nf -c configs/singularity.config nextflow run Cecret.nf -c configs/docker.config ``` -# Default file structure +# Default file structure (can be adjusted with 'params.reads', 'params.single_reads', and 'params.fastas') -### Paired-end fastq.gz +### Paired-end fastq.gz Paired-end fastq.gz (ending with 'fastq', 'fastq.gz', 'fq', or 'fq.gz') reads as follows or designate directory with 'params.reads' or '--reads' ``` directory @@ -64,7 +64,7 @@ directory WARNING : single and paired-end reads **cannot** be in the same directory -### Fasta files +### Fasta files Fasta files (ending with 'fa', 'fasta', or 'fna') as follows or designate directory with 'params.fastas' or '--fastas' ``` directory @@ -72,7 +72,7 @@ directory └── *fasta ``` -### MultiFasta files +### MultiFasta files MultiFasta files (ending with 'fa', 'fasta', or 'fna') as follows or designate directory with 'params.multifastas' or '--multifastas' ``` directory @@ -106,7 +106,7 @@ For the sake of simplicity, processes in this workflow are designated 1 CPU, a m The main [Cecret.nf](./Cecret.nf) file will attempt to determine how many cpus are available, and will set `params.maxcpus` to the number of cpus available. This option apparently caused havoc for running this workflow in the cloud and other resource management systems, so by default this is overridden when using a `-profile` to `'params.maxcpus = 8'` in [config template](./configs/cecret_config_template.config). -The **End User** can adjust this by specifying the maximum cpus that one process can take in the config file `'params.maxcpus = '` or on the command line +The **End User** can adjust this by specifying the maximum cpus that one process can take in the config file `'params.maxcpus = '` or on the command line ``` nextflow run UPHL-BioNGS/Cecret -profile singularity --maxcpus ``` @@ -115,7 +115,7 @@ It is important to remember that nextflow will attempt to utilize all CPUs avail ## Determining depth for base calls Sequencing has an intrinsic amount of error for every predicted base on a read. This error is reduced the more reads there are. As such, there is a minimum amount of depth that is required to call a base with ivar consensus, ivar variants, and bcftools variants. The main assumption of using this workflow is that the virus is clonal (i.e. only one infection represented in a sample) and created via pcr amplified libraries. The default depth for calling bases or finding variants is set with 'params.minimum_depth' with the default value being `'params.minimum_depth = 100'`. This parameter can be adjusted by the **END USER** in a config file or on the command line. -A corresponding parameter is 'params.mpileup_depth' (default of `'params.mpileup_depth = 8000'`), which is the number of reads that samtools (used by ivar) or bcftools uses to put into memory for any given position. If the **END USER** is experiencing memory issues, this number may need to be decreased. +A corresponding parameter is 'params.mpileup_depth' (default of `'params.mpileup_depth = 8000'`), which is the number of reads that samtools (used by ivar) or bcftools uses to put into memory for any given position. If the **END USER** is experiencing memory issues, this number may need to be decreased. ## Optional toggles: @@ -144,7 +144,7 @@ nextflow run UPHL-BioNGS/Cecret -profile singularity --aligner minimap2 Or set `params.aligner = 'minimap2'` in a config file ## Determining relatedness -To create a multiple sequence alignment and corresponding phylogenetic tree and SNP matrix, set `params.relatedness = true` or +To create a multiple sequence alignment and corresponding phylogenetic tree and SNP matrix, set `params.relatedness = true` or ``` nextflow run UPHL-BioNGS/Cecret -profile singularity --relatedness true ``` @@ -158,7 +158,7 @@ Or set `params.msa = 'nextalign'` and `params.relatedness = true` in a config fi ``` nextflow run UPHL-BioNGS/Cecret -profile singularity --relatedness true --msa nextclade ``` -Or set `params.msa = 'nextclade'` and `params.relatedness = true` in a config file. +Or set `params.msa = 'nextclade'` and `params.relatedness = true` in a config file. WARNING : the aligned fasta from nextclade does not include a reference sequence. If this is desired for iqtree2, a fasta of the reference MUST be included with the input files and the outgroup CAN be specified with `params.iqtree2_options = '-ninit 2 -n 2 -me 0.05 -m GTR -o '`. Specifying the outgroup via `'params.iqtree2_outgroup'` will not be used. @@ -189,14 +189,16 @@ params.kraken2_organism = "Severe acute respiratory syndrome-related coronavirus - [fastqc](https://github.com/s-andrews/FastQC) - for QC metrics - [bedtools](https://bedtools.readthedocs.io/en/latest/) - for depth estimation over amplicons - [kraken2](https://ccb.jhu.edu/software/kraken2/) - for read classification -- [pangolin](https://github.com/cov-lineages/pangolin) - for lineage classification -- [nextclade](https://clades.nextstrain.org/) - for clade classification +- [pangolin](https://github.com/cov-lineages/pangolin) - for SARS-CoV-2 lineage classification +- [freyja](https://github.com/andersen-lab/Freyja) - for multiple SARS-CoV-2 lineage classifications +- [nextclade](https://clades.nextstrain.org/) - for SARS-CoV-2 clade classification - [vadr](https://github.com/ncbi/vadr) - for annotating fastas like NCBI - [mafft](https://mafft.cbrc.jp/alignment/software/) - for multiple sequence alignment (optional, relatedness must be set to "true") - [snp-dists](https://github.com/tseemann/snp-dists) - for relatedness determination (optional, relatedness must be set to "true") - [iqtree2](http://www.iqtree.org/) - for phylogenetic tree generation (optional, relatedness must be set to "true") - [nextalign](https://github.com/neherlab/nextalign) - for phylogenetic tree generation (optional, relatedness must be set to "true", and msa must be set to "nextalign") - [bamsnap](https://github.com/parklab/bamsnap) - to create images of SNPs +- [multiqc](https://multiqc.info/) - summary of results ### Turning off unneeded processes It came to my attention that some processes (like bcftools) do not work consistently. Also, they might take longer than wanted and might not even be needed for the end user. Here's the processes that can be turned off with their default values: @@ -214,6 +216,7 @@ params.kraken2 = false # used to classify reads and needs a c params.bedtools_multicov = true # bedtools multicov for coverage approximation of amplicons params.nextclade = true # SARS-CoV-2 clade determination params.pangolin = true # SARS-CoV-2 lineage determination +params.freyja = true # multiple SARS-CoV-2 lineage determination params.vadr = false # NCBI fasta QC params.relatedness = false # create multiple sequence alignments with input fastq and fasta files params.snpdists = true # creates snp matrix from mafft multiple sequence alignment @@ -221,6 +224,7 @@ params.iqtree2 = true # creates phylogenetic tree from mafft params.bamsnap = false # can be really slow. Works best with bcftools variants. An example bamsnap image is below. params.rename = false # needs a corresponding sample file and will rename files for GISAID and NCBI submission params.filter = false # takes the aligned reads and turns them back into fastq.gz files +params.multiqc = true # aggregates data into single report ``` ### Add Genbank parsable header to consensus fasta @@ -278,6 +282,15 @@ cecret # results from this workflow │   ├── SRR13957125.consensus.fa │   ├── SRR13957170.consensus.fa │   └── SRR13957177.consensus.fa +├── dataset # generated by nextclade +│   ├── genemap.gff +│   ├── primers.csv +│   ├── qc.json +│   ├── reference.fasta +│   ├── sequences.fasta +│   ├── tag.json +│   ├── tree.json +│   └── virus_properties.json ├── fastp # optional tools for cleaning reads when 'params.cleaner = fastp' │   ├── SRR13957125_clean_PE1.fastq.gz │   ├── SRR13957125_clean_PE2.fastq.gz @@ -314,16 +327,37 @@ cecret # results from this workflow │   ├── SRR13957177_filtered_R1.fastq.gz │   ├── SRR13957177_filtered_R2.fastq.gz │   └── SRR13957177_filtered_unpaired.fastq.gz +├── freyja # finding co-lineages +│   ├── aggregated-freyja.png +│   ├── aggregated-freyja.tsv +│   ├── SRR13957125_boot.tsv_lineages.csv +│   ├── SRR13957125_boot.tsv_summarized.csv +│   ├── SRR13957125_demix.tsv +│   ├── SRR13957125_depths.tsv +│   ├── SRR13957125_variants.tsv +│   ├── SRR13957170_boot.tsv_lineages.csv +│   ├── SRR13957170_boot.tsv_summarized.csv +│   ├── SRR13957170_demix.tsv +│   ├── SRR13957170_depths.tsv +│   ├── SRR13957170_variants.tsv +│   ├── SRR13957177_boot.tsv_lineages.csv +│   ├── SRR13957177_boot.tsv_summarized.csv +│   ├── SRR13957177_demix.tsv +│   ├── SRR13957177_depths.tsv +│   └── SRR13957177_variants.tsv ├── iqtree2 # phylogenetic tree that is generated with 'params.relatedness = true' │   ├── iqtree2.iqtree │   ├── iqtree2.log │   ├── iqtree2.mldist │   └── iqtree2.treefile ├── ivar_trim # bam files after primers have been trimmed off the reads with ivar +│   ├── SRR13957125_ivar.log │   ├── SRR13957125.primertrim.sorted.bam │   ├── SRR13957125.primertrim.sorted.bam.bai +│   ├── SRR13957170_ivar.log │   ├── SRR13957170.primertrim.sorted.bam │   ├── SRR13957170.primertrim.sorted.bam.bai +│   ├── SRR13957177_ivar.log │   ├── SRR13957177.primertrim.sorted.bam │   └── SRR13957177.primertrim.sorted.bam.bai ├── ivar_variants # tsv and vcf files of variants identified in sample @@ -341,8 +375,22 @@ cecret # results from this workflow │   └── processes* │      ├── sample.run_id.err │      └── sample.run_id.log -├── mafft # multiple sequence alignment created when 'params.relatedness = true' +├── mafft # multiple sequence alignment created when 'params.relatedness = true' │   └── mafft_aligned.fasta +├── multiqc # aggregates data into single report +│   ├── multiqc_data +│   │   ├── multiqc_citations.txt +│   │   ├── multiqc_data.json +│   │   ├── multiqc_fastqc.txt +│   │   ├── multiqc_general_stats.txt +│   │   ├── multiqc_ivar_primers.txt +│   │   ├── multiqc_ivar_summary.txt +│   │   ├── multiqc.log +│   │   ├── multiqc_samtools_flagstat.txt +│   │   ├── multiqc_samtools_stats.txt +│   │   ├── multiqc_seqyclean.txt +│   │   └── multiqc_sources.txt +│   └── multiqc_report.html ├── nextclade # nextclade reports │   ├── combined.fasta │   ├── nextclade.aligned.fasta @@ -372,31 +420,35 @@ cecret # results from this workflow │   ├── SRR13957170_ampliconstats.txt │   └── SRR13957177_ampliconstats.txt ├── samtools_coverage # coverage and metrics as determined by samtools -│   └── aligned -│   ├── SRR13957125.cov.hist -│   ├── SRR13957125.cov.txt -│   ├── SRR13957170.cov.hist -│   ├── SRR13957170.cov.txt -│   ├── SRR13957177.cov.hist -│   └── SRR13957177.cov.txt +│   ├── SRR13957125.cov.aligned.hist +│   ├── SRR13957125.cov.aligned.txt +│   ├── SRR13957125.cov.trimmed.hist +│   ├── SRR13957125.cov.trimmed.txt +│   ├── SRR13957170.cov.aligned.hist +│   ├── SRR13957170.cov.aligned.txt +│   ├── SRR13957170.cov.trimmed.hist +│   ├── SRR13957170.cov.trimmed.txt +│   ├── SRR13957177.cov.aligned.hist +│   ├── SRR13957177.cov.aligned.txt +│   ├── SRR13957177.cov.trimmed.hist +│   └── SRR13957177.cov.trimmed.txt ├── samtools_depth # the number of reads -│   ├── aligned -│   │   ├── SRR13957125.depth.txt -│   │   ├── SRR13957170.depth.txt -│   │   └── SRR13957177.depth.txt -│   └── trimmed -│   ├── SRR13957125.depth.txt -│   ├── SRR13957170.depth.txt -│   └── SRR13957177.depth.txt +│   ├── SRR13957125.depth.aligned.txt +│   ├── SRR13957125.depth.trimmed.txt +│   ├── SRR13957170.depth.aligned.txt +│   ├── SRR13957170.depth.trimmed.txt +│   ├── SRR13957177.depth.aligned.txt +│   └── SRR13957177.depth.trimmed.txt ├── samtools_flagstat # flag information -│   ├── aligned -│   │   ├── SRR13957125.flagstat.txt -│   │   ├── SRR13957170.flagstat.txt -│   │   └── SRR13957177.flagstat.txt -│   └── trimmed -│   ├── SRR13957125.flagstat.txt -│   ├── SRR13957170.flagstat.txt -│   └── SRR13957177.flagstat.txt +│   ├── SRR13957125.flagstat.aligned.txt +│   ├── SRR13957125.flagstat.trimmed.txt +│   ├── SRR13957125.flagstat.txt +│   ├── SRR13957170.flagstat.aligned.txt +│   ├── SRR13957170.flagstat.trimmed.txt +│   ├── SRR13957170.flagstat.txt +│   ├── SRR13957177.flagstat.aligned.txt +│   ├── SRR13957177.flagstat.trimmed.txt +│   └── SRR13957177.flagstat.txt ├── samtools_plot_ampliconstats # plots of the ampliconstats for troubleshooting purposes │   ├── SRR13957125 │   ├── SRR13957125-combined-amp.gp @@ -504,14 +556,15 @@ cecret # results from this workflow │   ├── SRR13957177-SRR13957177.primertrim.sorted-tsize.gp │   └── SRR13957177-SRR13957177.primertrim.sorted-tsize.png ├── samtools_stats # stats as determined by samtools -│   ├── aligned -│   │   ├── SRR13957125.stats.txt -│   │   ├── SRR13957170.stats.txt -│   │   └── SRR13957177.stats.txt -│   └── trimmed -│   ├── SRR13957125.stats.trim.txt -│   ├── SRR13957170.stats.trim.txt -│   └── SRR13957177.stats.trim.txt +│   ├── SRR13957125.stats.aligned.txt +│   ├── SRR13957125.stats.trimmed.txt +│   ├── SRR13957125.stats.txt +│   ├── SRR13957170.stats.aligned.txt +│   ├── SRR13957170.stats.trimmed.txt +│   ├── SRR13957170.stats.txt +│   ├── SRR13957177.stats.aligned.txt +│   ├── SRR13957177.stats.trimmed.txt +│   └── SRR13957177.stats.txt ├── seqyclean # reads that have had PhiX and adapters removed │   ├── Combined_SummaryStatistics.tsv │   ├── SRR13957125_clean_PE1.fastq.gz @@ -539,15 +592,12 @@ cecret # results from this workflow │   ├── UT-UPHL-2103929243.gisaid.fa │   ├── UT-UPHL-2103954304_filtered_R1.fastq.gz │   └── UT-UPHL-2103954304_filtered_R2.fastq.gz -├── summary # summary files with condensed results +├── summary # convenient summary files +│   ├── combined_summary.csv │   ├── SRR13957125.summary.csv -│   ├── SRR13957125.summary.txt │   ├── SRR13957170.summary.csv -│   ├── SRR13957170.summary.txt -│   ├── SRR13957177.summary.csv -│   └── SRR13957177.summary.txt -├── summary.csv -└── vadr # QC that mimics NCBI's metrics +│   └── SRR13957177.summary.csv +└── vadr # consensus file QC ├── combined.fasta ├── trimmed.fasta ├── vadr.vadr.alc @@ -580,7 +630,7 @@ work # nextflow's working directories ``` - + **A FILE THAT THE END USER CAN COPY AND EDIT IS FOUND AT [configs/cecret_config_template.config](configs/cecret_config_template.config)** This file contains all of the configurable parameters with their default values. Use `'-c'` to specify the edited config file. If the **End User** is using some sort of cloud or HPC setup, it is highly recommended that this file is copied and edited appropriately. A limited list of parameters is listed below: @@ -605,11 +655,26 @@ This file contains all of the configurable parameters with their default values. * Email me * Send me a message on slack -Be sure to include the command that was used, what config file was used, and what the **nextflow** error was. +Be sure to include the command that was used, what config file was used, and what the **nextflow** error was. + +## What is the MultiQC report? +The multiqc report aggregates data across your samples into one file. Open the 'cecret/multiqc/multiqc_report.html' file with your favored browser. There tables and graphs are generated for 'General Statistics', 'Samtools stats', 'Samtools flagstats', 'FastQC', 'iVar', 'SeqyClean', 'Fastp', 'Pangolin', and 'Kraken2'. + +### Example fastqc graph +![alt text](images/multiqc_fastqc.png) + +### Example kraken2 graph +![alt text](images/multiqc_kraken2.png) + +### Example iVar graph +![alt text](images/multiqc_ivar.png) + +### Example pangolin graph +![alt text](images/multiqc_pangolin.png) ## What if I want to test the workflow? -In the history of this repository, there actually was an attempt to store fastq files here that the **End User** could use to test out this workflow. This made the repository very large and difficult to download. +In the history of this repository, there actually was an attempt to store fastq files here that the **End User** could use to test out this workflow. This made the repository very large and difficult to download. Instead, it recommended that the **End User** uses the [SARS-CoV-2 datasets](https://github.com/CDCgov/datasets-sars-cov-2), an effort of the CDC to provide a benchmark dataset for validating bioinformatic workflows. Fastq files from the [nonviovoc](https://github.com/CDCgov/datasets-sars-cov-2/blob/master/datasets/sars-cov-2-nonvoivoc.tsv), [voivoc](https://github.com/CDCgov/datasets-sars-cov-2/blob/master/datasets/sars-cov-2-voivoc.tsv), and [failed](https://github.com/CDCgov/datasets-sars-cov-2/blob/master/datasets/sars-cov-2-failedQC.tsv) projects were downloaded from the SRA and put through this workflow. The summary files are included in the data directory under the following filenames for comparison: - [data/default_datasets_summary.csv](./data/default_datasets_summary.csv) : Using the default options @@ -618,7 +683,7 @@ Instead, it recommended that the **End User** uses the [SARS-CoV-2 datasets](htt The expected amount of time to run this workflow with 250 G RAM and 48 CPUs, 'params.maxcpus = 8', and 'params.medcpus = 4' is ~42 minutes. This corresponded with 25.8 CPU hours. -## What if I just want to annotate some SARS-CoV-2 fastas with pangolin, nextclade and vadr? +## What if I just want to annotate some SARS-CoV-2 fastas with pangolin, freyja, nextclade and vadr? ``` # for a collection of fastas nextflow run UPHL-BioNGS/Cecret -profile singularity --fastas @@ -640,7 +705,7 @@ nextflow run UPHL-BioNGS/Cecret -profile singularity --relatedness true --fastas ## Where is an example config file? The **End User** is more than welcome to look at an example [here](./configs/cecret_config_template.config). Just remove the comments for the parameters that need to be adjusted and specify with `-c`. -At UPHL, our config file is small enough to be put as a profile option, but the text of the config file would be as follows: +At UPHL, our config file is small enough to be put as a profile option, but the text of the config file would be as follows: ``` singularity.enabled = true @@ -660,9 +725,9 @@ nextflow run Cecret.nf -c /config.config ## Is there a way to determine if certain amplicons are failing? -There are two ways to do this. +There are two ways to do this. -### With bedtools multicov : +### With bedtools multicov : `cecret/bedtools_multicov` has a file for each sample. This is standard bedtools multicov output, so it doesn't have a header. @@ -679,7 +744,7 @@ Row number 126 (FDEPTH) has a column for each amplicon (also without a header). ``` grep "^FDEPTH" cecret/samtools_ampliconstats/* > samtools_ampliconstats_all.tsv -``` +``` There are corresponding images in `cecret/samtools_plot_ampliconstats` for each sample. @@ -690,7 +755,7 @@ There are corresponding images in `cecret/samtools_plot_ampliconstats` for each There's nothing wrong with the bcftools process, and the vcf created by bcftools is rather handy for additional analyses. The `'staphb/bcftools:latest'` container is really popular, and has issues downloading during high traffic times. The maintainers of this repository don't have the time to handle issues of users not understanding why the container did not download. /Sorry -To to get the vcf of variants from bcftools, set `params.bcftools_variants = true` +To to get the vcf of variants from bcftools, set `params.bcftools_variants = true` ## What is the difference between `params.amplicon_bed` and `params.primer_bed`? @@ -725,7 +790,9 @@ MN908947.3 2850 3183 10 2 + ``` Due to the many varieties of primer bedfiles, it is best if the **End User** supplied this file for custom primer sequences. -## What if I am using an amplicon based library that is not SARS-CoV-2? +## What if I am using an amplicon-based library that is not SARS-CoV-2? + +First of all, this is a great thing! [Let me know](https://github.com/UPHL-BioNGS/Cecret/issues) if tools specific for your organism should be added to this workflow. In a config file, change the following relevant parameters: ``` @@ -736,17 +803,18 @@ params.gff_file or set params.ivar_variants = false ``` And set ``` -params.pangolin = false +params.pangolin = false +params.freyja = false params.nextclade = false or adjust nexclade_prep_options from '--name sars-cov-2' to the name of the relevent dataset params.vadr = false or configure the vadr container appropriately and params.vadr_reference ``` ## What if I need to filter out human reads or I only want reads that map to my reference? -Although not perfect, if `'params.filter = true'`, then only the reads that were mapped to the reference are returned. This _should_ eliminate all human contamination (as long as human is not part of the supplied reference). +Although not perfect, if `'params.filter = true'`, then only the reads that were mapped to the reference are returned. This _should_ eliminate all human contamination (as long as human is not part of the supplied reference). ## This workflow has too many bells and whistles. I really only care about generating a consensus fasta. How do I get rid of all the extras? -Change the parameters in a config file and set most of them to false. +Change the parameters in a config file and set most of them to false. ``` params.fastqc = false @@ -760,6 +828,7 @@ params.samtools_ampliconstats = false params.samtools_plot_ampliconstats = false params.bedtools_multicov = false params.pangolin = false +params.freyja = false params.nextclade = false params.vadr = false ``` @@ -767,11 +836,16 @@ And, yes, this means I added some bells and whistles so the **End User** could t ## Can I get images of my SNPs and indels? -Yes. Set `params.bamsnap = true`. This is false by default because of how long it takes. It will work with variants called by `ivar_variants` and `bcftools_variants`, although it is **MUCH** faster with the vcf created by bcftools. +Yes. Set `params.bamsnap = true`. This is false by default because of how long it takes. It will work with variants called by `ivar_variants` and `bcftools_variants`, although it is **MUCH** faster with the vcf created by bcftools. -Warning : will not work on all variants. This is due to how bamsnap runs. It is even less likely to work on indels. +Warning : will not work on all variants. This is due to how bamsnap runs. It is even less likely to work on indels. ### Sample bamsnap plot ![alt text](images/sample_bamsnap.png) + +## What is in the works to get added to 'Cecret'? (These are waiting for either versions to stablize or a docker container to be available.) +- https://github.com/chrisruis/bammix +- https://github.com/lenaschimmel/sc2rf + ![alt text](https://uphl.utah.gov/wp-content/uploads/New-UPHL-Logo.png) diff --git a/bin/.tests.notower.sh b/bin/.tests.notower.sh new file mode 100755 index 0000000..8482b4c --- /dev/null +++ b/bin/.tests.notower.sh @@ -0,0 +1,99 @@ +#/bin/bash +#nextflow ~/sandbox/Cecret/Cecret.nf -profile singularity --reads /home/eriny/sandbox/test_files/cecret/reads --outdir tests -with-tower -resume + +test=$1 + +if [ -z "$test" ]; then test="small" ; fi + +if [ "$test" == "small" ] +then + options=("reads" "single_reads" "fastas") + + for option in ${options[@]} + do + # defaults + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile singularity,artic_V3 \ + --$option /home/eriny/sandbox/test_files/cecret/$option \ + --outdir singularity_defaults_$option + + # removed test for bamsnap and rename because of lack of interest + # attempted bcftools and filter + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile singularity,artic_V3 \ + --$option /home/eriny/sandbox/test_files/cecret/$option \ + --outdir all_on_$option \ + --bcftools_variants true \ + --filter true \ + -resume + + # removing primer trimming + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile singularity,artic_V3 \ + --$option /home/eriny/sandbox/test_files/cecret/$option \ + --outdir nontrimmed_$option \ + --trimmer 'none' \ + -resume + + # changing the cleaner, aligner, and trimmer + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile singularity,artic_V3 \ + --$option /home/eriny/sandbox/test_files/cecret/$option \ + --outdir toggled_$option \ + --cleaner 'fastp' \ + --trimmer 'samtools' \ + --aligner 'minimap2' \ + -resume + + # with UPHL's config + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile uphl,artic_V3 \ + --$option /home/eriny/sandbox/test_files/cecret/$option \ + --outdir uphl_$option \ + -resume + done + + # multifasta + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile singularity,artic_V3 \ + --reads /home/eriny/sandbox/test_files/cecret/reads \ + --single-reads /home/eriny/sandbox/test_files/cecret/single-reads \ + --fastas /home/eriny/sandbox/test_files/cecret/fastas \ + --multifastas /home/eriny/sandbox/test_files/cecret/multifasta \ + --outdir kitchen_sink + + # empty + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile singularity,artic_V3 \ + --reads doesntexit \ + --single-reads willnotexist \ + --fastas shouldntexit \ + --outdir empty + +else + # CDC's test data with relatedness + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile singularity,artic_V3 \ + --reads /home/eriny/sandbox/sars-cov-2-datasets/reads \ + --outdir default_datasets \ + --relatedness true + + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile uphl,artic_V3 \ + --reads /home/eriny/sandbox/sars-cov-2-datasets/reads \ + --outdir uphl_datasets \ + -resume \ + --relatedness true + + # CDC's test data with relatedness using nextalign + nextflow ~/sandbox/Cecret/Cecret.nf \ + -profile singularity,artic_V3 \ + --reads /home/eriny/sandbox/sars-cov-2-datasets/reads \ + --outdir toggled_datasets \ + --cleaner 'fastp' \ + --trimmer 'samtools' \ + --aligner 'minimap2' \ + --relatedness true \ + --msa 'nextalign' \ + -resume +fi diff --git a/bin/combine_results.py b/bin/combine_results.py index c40d581..3abae3d 100755 --- a/bin/combine_results.py +++ b/bin/combine_results.py @@ -6,6 +6,7 @@ pangolin_file='lineage_report.csv' nextclade_file='nextclade.csv' vadr_file='vadr.csv' +freyja_file='aggregated-freyja.tsv' summary_file='combined_summary.csv' summary_df = pd.read_csv(summary_file, dtype = str) @@ -41,7 +42,7 @@ columns = ['nextclade_clade'] + columns + nextclade_columns if exists(pangolin_file) : - pangolin_df = pd.read_csv(pangolin_file, dtype = str, usecols = ['taxon', 'lineage', 'status', 'scorpio_call', 'version', 'pangolin_version', 'pango_version', 'pangoLEARN_version']) + pangolin_df = pd.read_csv(pangolin_file, dtype = str) pangolin_df=pangolin_df.add_prefix('pangolin_') pangolin_columns = list(pangolin_df.columns) pangolin_columns.remove('pangolin_taxon') @@ -53,4 +54,17 @@ summary_df.drop('pangolin_taxon', axis=1, inplace=True) columns = ['pangolin_lineage'] + columns + pangolin_columns +if exists(freyja_file) : + freyja_df = pd.read_table(freyja_file, dtype = str, sep="\t") + freyja_df = freyja_df.add_prefix('freyja_') + freyja_df['freyja_Unnamed: 0'] = freyja_df['freyja_Unnamed: 0'].str.replace("_variants.tsv", "") + freyja_columns = list(freyja_df.columns) + freyja_columns.remove('freyja_Unnamed: 0') + + summary_df = pd.merge(summary_df, freyja_df, left_on = 'sample_id', right_on = 'freyja_Unnamed: 0', how = 'outer') + summary_df['sample_id'].fillna(summary_df['freyja_Unnamed: 0'], inplace=True) + summary_df['fasta_line'].fillna(summary_df['freyja_Unnamed: 0'], inplace=True) + summary_df.drop('freyja_Unnamed: 0', axis=1, inplace=True) + columns = columns + freyja_columns + summary_df.to_csv('cecret_results.csv', columns = ['sample_id','sample'] + columns, index=False) diff --git a/configs/cecret_config_template.config b/configs/cecret_config_template.config index 54d9e08..4eedd25 100644 --- a/configs/cecret_config_template.config +++ b/configs/cecret_config_template.config @@ -88,6 +88,8 @@ nextalign_container = 'nextstrain/nextalign:latest' snp_dists_container = 'staphb/snp-dists:latest' iqtree2_container = 'staphb/iqtree2:latest' pandas_container = 'quay.io/biocontainers/pandas:1.1.5' +multiqc_container = 'ewels/multiqc:latest' +freyja_container = 'staphb/freyja:latest' //# Workflow parameters -------------------------------------- @@ -120,15 +122,15 @@ pandas_container = 'quay.io/biocontainers/pandas:1.1.5' //params.filter = true //# For process ivar_trim -//params.trimmer == 'ivar' +//params.trimmer = 'ivar' //params.ivar_trim_options = '' //# For process samtools_ampliconclip -//params.trimmer == 'samtools' +//params.trimmer = 'samtools' //params.samtools_ampliconclip_options = '' //# trimming can also be skipped with -//params.trimmer == 'none' +//params.trimmer = 'none' //# For process ivar_variants //params.ivar_variants = true @@ -197,6 +199,15 @@ pandas_container = 'quay.io/biocontainers/pandas:1.1.5' //params.pangolin_options = '' //params.pangolin = true +//# For process freyja +//params.freyja = true +//params.freyja_variants_options='' +//params.freyja_demix_options='' +//params.freyja_boot_options='--nb 1000' +//params.freyja_aggregate_options='' +//params.freyja_plot_options='' +//params.freyja_plot_filetype='png' + //# For process nextclade //params.nextclade_dataset = 'sars-cov-2' //params.nextclade_options = '' @@ -214,13 +225,17 @@ pandas_container = 'quay.io/biocontainers/pandas:1.1.5' //# params.minimum_depth is shared with ivar_variants, ivar_consensus, and samtools_depth //params.minimum_depth = 100 +//# For process multiqc +//params.multiqc = true +//params.multiqc_options = '' + //# For process mafft -//params.msa == 'mafft' +//params.msa = 'mafft' //params.mafft_options = '--maxambiguous 0.5' //params.relatedness = true //# For process nextalign -//params.msa == 'nextalign' +//params.msa = 'nextalign' //params.nextalign_options = '--genes E,M,N,ORF1a,ORF1b,ORF3a,ORF6,ORF7a,ORF7b,ORF8,ORF9b,S --include-reference' //params.relatedness = true @@ -348,8 +363,17 @@ process { container = pangolin_container } + withName:freyja{ + container = freyja_container + } + + withName:freyja_aggregate{ + container = freyja_container + } + withName:nextclade{ cpus = params.medcpus + memory = '4 GB' container = nextclade_container } @@ -367,6 +391,10 @@ process { container = pandas_container } + withName:multiqc{ + container = multiqc_container + } + withName:mafft{ cpus = params.maxcpus container = mafft_container diff --git a/data/default_datasets_summary.csv b/data/default_datasets_summary.csv index e7a79b9..035bf9c 100644 --- a/data/default_datasets_summary.csv +++ b/data/default_datasets_summary.csv @@ -1,75 +1,344 @@ -sample_id,sample,pangolin_lineage,nextclade_clade,fastqc_raw_reads_1,fastqc_raw_reads_2,seqyclean_pairs_kept_after_cleaning,seqyclean_percent_kept_after_cleaning,depth_after_trimming,1X_coverage_after_trimming,num_pos_100X,insert_size_before_trimming,insert_size_after_trimming,ivar_num_variants_identified,bedtools_num_failed_amplicons,samtools_num_failed_amplicons,num_N,num_degenerage,num_non-ambiguous,num_total,cleaner_version,aligner_version,trimmer_version,ivar_version,nextclade_qc.overallScore,nextclade_qc.overallStatus,pangolin_scorpio_call,pangolin_version,pangolin_pangolin_version,pangolin_pangoLEARN_version,pangolin_pango_version,pangolin_status -SRR13606410,SRR13606410,P.2,20B,92107,92107,87333,94.8169,1219.75,99.7358,29805,381.5,383.0,20,0,0,19,0,29805,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,Zeta (P.2-like),PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298165,SRR16298165,None,20B,533855,533855,499859,93.632,3900.34,43.3134,10764,158.6,158.8,6,48,46,16112,0,10770,26882,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3429.620631,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13433883,SRR13433883,B.1.258.23,20A,106223,106223,103545,97.4789,892.565,99.8662,28371,275.6,275.6,25,0,3,1515,0,28378,29893,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,20.250000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13001544,SRR13001544,B.1.199,20A,152965,152965,145024,94.8086,1995.34,99.8796,29805,379.3,381.2,6,0,0,62,0,29805,29867,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12901576,SRR12901576,B.1.515,20C,363267,363267,354907,97.6987,3151.37,99.3914,28880,254.8,254.7,7,0,0,1012,0,28888,29900,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,6.953964,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13603869,SRR13603869,B.1.427,21C (Epsilon),35473,35473,33496,94.4267,316.52,98.3982,24179,156.6,156.8,14,1,5,5657,0,24192,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,393.654993,bad,Epsilon (B.1.427-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13004400,SRR13004400,B.1.264,20C,34961,34961,32748,93.6701,478.153,99.7659,28339,384.1,385.2,7,0,0,1472,0,28361,29833,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,18.842030,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298169,SRR16298169,None,19B,223543,223543,207555,92.8479,1460.08,91.7968,19275,145.8,159.1,3,5,14,10413,1,19312,29726,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1403.918642,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13500958,SRR13500958,P.2,20B,73899,73899,69791,94.4411,964.395,99.7659,28015,379.9,381.4,22,0,0,1797,0,28036,29833,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,30.740864,mediocre,Zeta (P.2-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5556343,ERR5556343,P.1,"20J (Gamma, V3)",216817,216817,215689,99.4797,2590.21,99.6656,27915,385.5,385.7,32,0,0,1838,0,27964,29802,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,32.447791,mediocre,Gamma (P.1-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298163,SRR16298163,None,,162,162,136,83.9506,0.970204,40.3739,0,123.1,125.1,0,98,98,29677,0,0,29677,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13422799,SRR13422799,B.1.429,21C (Epsilon),76082,76082,72210,94.9108,954.433,99.8462,29253,381.3,382.2,31,0,1,638,0,29253,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1.567133,good,Epsilon (B.1.429-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13668148,SRR13668148,B.1.570,20C,200629,200629,161505,80.4993,1492.37,98.9901,23317,154.4,155.4,10,0,0,6548,0,23346,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,535.493882,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5743893,ERR5743893,B.1.617.1,21B (Kappa),198314,198314,166710,84.0637,1821.9,98.8095,27600,386.5,386.8,23,1,1,2246,0,27626,29872,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,51.946722,mediocre,B.1.617.1-like,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13297857,SRR13297857,B.1.450,20C,51105,51105,25421,49.7427,372.05,99.6756,26404,387.4,388.3,4,0,0,3192,0,26614,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,114.727901,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12212912,SRR12212912,B.1.112,20A,274115,274115,267908,97.7356,2458.45,99.893,29415,267.4,267.3,10,0,0,480,0,29423,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.444444,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298174,SRR16298174,None,,148231,148231,134328,90.6207,0.360766,19.2355,0,62.3,127.6,0,98,98,29440,0,0,29440,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR16298157,SRR16298157,None,,1691,1691,48,2.83856,0,0,0,0.0,0.0,0,98,98,0,0,0,0,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13527262,SRR13527262,B.1.1.450,20B,209689,209689,193935,92.487,1687.27,97.4016,24644,185.8,186.0,11,1,6,5232,0,24667,29899,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,333.671111,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13373851,SRR13373851,B.1.492,20C,184210,184210,169443,91.9836,1553.81,99.6455,29661,152.8,153.1,8,0,0,129,0,29668,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298164,SRR16298164,None,,37159,37159,36931,99.3864,0.0650102,4.07651,0,166.6,176.8,0,98,98,29849,0,0,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR12162365,SRR12162365,B.1.1.136,20B,258545,258545,244155,94.4342,2036.28,99.6756,29564,190.6,190.9,9,0,0,242,0,29564,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR14241199,SRR14241199,B.1.526,21F (Iota),222498,222498,200666,90.1878,2842.08,99.9164,28449,385.7,385.8,25,0,0,1423,0,28449,29872,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,17.299438,good,Iota (B.1.526-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13687078,SRR13687078,B.1.1.362,20B,33826,33826,31549,93.2685,296.485,99.5118,26782,155.2,155.6,9,0,1,3068,0,26828,29896,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,105.100466,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298167,SRR16298167,None,,1330,1330,96,7.21805,0.0167207,1.21393,0,363.0,363.0,0,98,98,363,0,0,363,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13062553,SRR13062553,B.1.265,20C,20718,20718,19623,94.7147,286.989,99.7759,27878,391.0,390.9,6,0,0,1934,0,27902,29836,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,36.624911,mediocre,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12733606,SRR12733606,B.1.390,20A,776002,776002,653607,84.2275,636.733,99.9799,29273,203.4,204.3,7,0,0,614,1,29282,29897,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,2.352483,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298160,SRR16298160,None,20A,14341,14341,13508,94.1915,108.457,95.7295,11093,173.5,173.8,5,8,38,18527,0,11177,29704,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,4557.250055,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13690003,SRR13690003,B.1.2,20C,753605,753605,706369,93.732,6275.35,99.9632,29597,198.1,198.3,18,0,0,296,7,29590,29893,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,49.000000,mediocre,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12751757,SRR12751757,D.2,20F,497470,497470,492069,98.9143,4292.07,97.5186,24044,210.7,211.1,14,0,3,5787,1,24061,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,413.992716,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12530461,SRR12530461,B.1.1.431,20B,584532,584532,575787,98.5039,4994.48,99.4649,27617,239.2,239.7,16,0,1,2247,0,27617,29864,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,52.000123,mediocre,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13129709,SRR13129709,D.3,20B,568486,568486,555853,97.7778,4611.04,99.8328,29547,215.9,216.2,14,0,0,304,0,29549,29853,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000219,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298170,SRR16298170,A.1,19B,606680,606680,554256,91.3589,4298.65,89.0279,24881,163.2,163.5,3,2,2,4931,0,24881,29812,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,294.186022,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12833718,SRR12833718,B.1.1.174,20B,651160,651160,606671,93.1677,5205.77,97.211,27112,185.8,186.2,14,0,3,2433,8,27120,29561,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,126.583611,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13526755,SRR13526755,B.1.1.418,20B,1068040,1068040,968596,90.6891,8293.36,99.8997,29782,179.7,179.9,18,0,0,91,0,29782,29873,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5181360,ERR5181360,B.1.525,21D (Eta),1500457,1500457,1492260,99.4537,17923,99.8361,29746,398.8,398.5,32,0,0,2195,0,27633,29828,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,49.259602,mediocre,Eta (B.1.525-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR11577968,SRR11577968,B.1.320,20C,436687,436687,433315,99.2278,3908.91,99.7693,29624,254.3,254.5,7,0,0,207,0,29627,29834,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298168,SRR16298168,A.1,19B,331747,331747,299640,90.3218,2780.74,98.8229,28845,162.9,163.1,3,1,1,942,0,28855,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,5.653827,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13574337,SRR13574337,B.1.375,20C,1245538,1245538,1053080,84.5482,1554.99,99.9933,29827,284.4,285.4,15,0,0,71,0,29826,29897,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5181310,ERR5181310,B.1.525,21D (Eta),912571,912571,909776,99.6937,10999.1,99.6154,29734,391.7,391.9,35,0,0,67,0,29732,29799,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,Eta (B.1.525-like),PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12763543,SRR12763543,B.1.1.463,20B,1236202,1236202,1093951,88.4929,9470.23,99.1941,27551,187.4,187.5,7,0,5,2340,0,27555,29895,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,57.086420,mediocre,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12661075,SRR12661075,B.1.452,20C,3399069,3399069,3018507,88.8039,26574.4,100,29815,187.6,187.7,8,0,0,88,0,29815,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5771988,ERR5771988,B.1.617.1,21B (Kappa),1111192,1111192,1107889,99.7028,13336.6,99.7826,29512,391.6,391.7,28,1,1,2618,0,27253,29871,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,73.705405,mediocre,B.1.617.1-like,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR11494584,SRR11494584,B.4.5,19A,604651,604651,598174,98.9288,5163.91,99.7425,29782,241.0,241.3,5,0,0,44,0,29782,29826,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13297853,SRR13297853,B.1.323,20C,372300,372300,316829,85.1005,4575,99.9197,29805,535.7,533.3,7,0,0,74,0,29805,29879,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13195337,SRR13195337,B.1.309,20C,2277602,2277602,1320912,57.9957,9910.91,99.6489,29782,143.4,144.3,14,0,0,16,0,29782,29798,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13195265,SRR13195265,B.1.1.205,20B,1946500,1946500,1035164,53.1808,7529.44,99.5954,29567,134.7,135.9,9,0,0,194,0,29588,29782,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5743043,ERR5743043,AY.46,21J (Delta),1890053,1890053,1883051,99.6295,22727.6,99.99,29639,391.8,391.9,26,0,0,9105,0,20789,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1063.484568,bad,Delta (B.1.617.2-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13486908,SRR13486908,B.1.385,20A,3297513,3297513,3038569,92.1473,14336,100,29869,256.6,257.5,17,0,0,34,0,29869,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1.562500,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5691945,ERR5691945,B.1.351,"20H (Beta, V2)",1735046,1735046,1723717,99.347,20605.5,99.9766,29569,390.9,391.2,23,0,1,7666,0,22215,29881,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,744.279232,bad,Beta (B.1.351-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR11915959,SRR11915959,B.35,19A,553601,553601,542581,98.0094,4599.47,99.8529,28759,235.3,235.7,8,0,1,1105,5,28756,29866,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,33.889232,mediocre,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12833927,SRR12833927,B.1.1.514,20B,1287220,1287220,1210340,94.0274,10624,98.7493,29470,190.6,190.8,8,0,1,88,0,29473,29561,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13511054,SRR13511054,B.1.526,21F (Iota),102908,102908,98829,96.0363,1368.17,99.7693,29795,383.9,384.5,22,0,0,29,0,29795,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,Iota (B.1.526-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13089080,SRR13089080,B.1.589,20C,37630,37630,26337,69.9894,381.88,99.7358,28855,403.9,402.7,9,0,0,900,0,28924,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,4.938272,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298175,SRR16298175,None,19A,142646,142646,132133,92.63,170.294,59.7331,6164,155.9,156.4,2,53,66,23682,0,6167,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,7499.560000,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR16298171,SRR16298171,B.1,20C,356628,356628,326814,91.64,2481.3,94.0006,25675,155.1,155.3,33,2,4,4177,2,25700,29879,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,817.132771,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13195052,SRR13195052,B.1.1.139,20B,416419,416419,387426,93.0375,3289.94,99.9732,29621,195.8,196.2,10,0,0,269,0,29633,29902,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5749609,ERR5749609,None,21J (Delta),2323723,2323723,2315943,99.6652,27728,99.9833,29729,391.3,391.4,26,0,0,10326,1,19567,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1379.884444,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR16298159,SRR16298159,None,,27131,27131,21036,77.5349,0.253821,15.266,0,93.6,151.4,0,98,98,29069,0,0,29069,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR12774785,SRR12774785,B.1.287,20C,29696,29696,27583,92.8846,250.013,98.8663,24539,150.6,150.9,7,0,4,5293,1,24597,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,342.975981,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13193342,SRR13193342,B.1.578,20C,78530,78530,74227,94.5206,1060.37,99.7759,29310,565.5,561.0,10,0,0,509,0,29327,29836,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.599191,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13689874,SRR13689874,B.1.1.512,20B,301254,301254,291105,96.6311,2601.95,99.8896,29512,224.9,225.1,27,0,0,389,0,29513,29902,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,21.115600,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13422802,SRR13422802,B.1.427,21C (Epsilon),146635,146635,139244,94.9596,1865.65,99.3445,29363,382.9,383.8,19,0,0,443,0,29363,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.280508,good,Epsilon (B.1.427-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298161,SRR16298161,None,20C,188463,188463,164636,87.3572,822.63,66.5351,12630,130.3,130.6,12,26,39,16440,0,12636,29076,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3629.632716,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13126740,SRR13126740,B.1,20A,33706,33706,31563,93.6421,283.858,97.6257,21822,152.3,152.9,4,0,10,7916,0,21880,29796,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,795.657833,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12192434,SRR12192434,B.1,20C,22164,22164,18803,84.8358,149.7,99.9599,25339,189.6,190.9,4,0,0,4352,0,25539,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,225.222277,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298158,SRR16298158,None,20A,300310,300310,268801,89.5078,755.487,40.4541,5484,143.4,143.9,8,68,71,24379,1,5483,29863,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,8010.586639,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR16298173,SRR16298173,B,19A,138431,138431,125512,90.6676,993.646,93.4455,25104,166.8,167.0,0,1,1,4733,1,25104,29838,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,270.567750,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298162,SRR16298162,None,,15303,15303,3518,22.989,15.7096,99.1707,0,124.0,127.2,0,3,92,29782,0,0,29782,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13358209,SRR13358209,B.1.1.440,20B,35450,35450,32711,92.2736,299.735,99.6455,25247,151.7,152.1,6,0,3,4476,0,25321,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,239.217778,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298166,SRR16298166,None,,6343,6343,69,1.08781,0.00344447,0.344447,0,100.0,0.0,0,98,98,7101,0,0,7101,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR16298172,SRR16298172,None,19A,2604,2604,2452,94.1628,20.6813,99.7826,211,197.4,198.9,0,2,86,29617,0,221,29838,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,11789.938121,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -ERR5405022,ERR5405022,B.1.1.7,"20I (Alpha, V1)",154545,154545,151242,97.8628,1236.53,99.7525,28291,182.4,182.9,35,0,0,1512,0,28300,29812,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,20.150123,good,Alpha (B.1.1.7-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13690340,SRR13690340,B.1.232,20A,333889,333889,301041,90.162,2691.74,100,29576,200.3,200.4,18,0,0,327,1,29575,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3.787778,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc +sample_id,sample,pangolin_lineage,nextclade_clade,fastqc_raw_reads_1,fastqc_raw_reads_2,seqyclean_pairs_kept_after_cleaning,seqyclean_percent_kept_after_cleaning,depth_after_trimming,1X_coverage_after_trimming,num_pos_100X,insert_size_before_trimming,insert_size_after_trimming,ivar_num_variants_identified,bedtools_num_failed_amplicons,samtools_num_failed_amplicons,num_N,num_degenerage,num_non-ambiguous,num_total,cleaner_version,aligner_version,trimmer_version,ivar_version,nextclade_qc.overallScore,nextclade_qc.overallStatus,pangolin_conflict,pangolin_ambiguity_score,pangolin_scorpio_call,pangolin_scorpio_support,pangolin_scorpio_conflict,pangolin_scorpio_notes,pangolin_version,pangolin_pangolin_version,pangolin_scorpio_version,pangolin_constellation_version,pangolin_is_designated,pangolin_qc_status,pangolin_qc_notes,pangolin_note,freyja_summarized,freyja_lineages,freyja_abundances,freyja_resid +SRR13001544,SRR13001544,B.1.199,20A,152965,152965,145024,94.8086,1995.34,99.8796,29805,379.3,381.2,6,0,0,62,0,29805,29867,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.2,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9887107280004006)]",['B.1.199' 'B.1.378' 'B.1.545' 'B.1.393'],[0.98461941 0.00187441 0.00118064 0.00103627],0.7294932367468199 +SRR16298171,SRR16298171,B.1,20C,356628,356628,326814,91.64,2481.3,94.0006,25675,155.1,155.3,33,2,4,4177,2,25700,29879,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,864.528604,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.15,Usher placements: B.1(2/2),"[('Other', 0.9782430294139861)]",['B.1.344' 'B.1.355' 'B.1.360' 'B.1.167' 'B.1.453'],[0.97280162 0.00178253 0.0013541 0.00130378 0.001001 ],8.903653341053312 +SRR13062553,SRR13062553,B.1.265,20C,20718,20718,19623,94.7147,286.989,99.7759,27878,391.0,390.9,6,0,0,1934,0,27902,29836,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,36.624911,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: B.1.265(1/1),"[('Other', 0.9999999999999897)]",['B.1.265'],[1.],0.634246919461033 +SRR16298161,SRR16298161,Unassigned,20C,188463,188463,164636,87.3572,822.63,66.5351,12630,130.3,130.6,12,26,39,16440,0,12636,29076,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3631.195216,bad,,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.58,,"[('Other', 0.9993582950550222)]",['B.1.2'],[0.9993583],1.984753715213297 +SRR12212912,SRR12212912,B.1.112,20A,274115,274115,267908,97.7356,2458.45,99.893,29415,267.4,267.3,10,0,0,480,0,29423,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.444444,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.112(1/1),"[('Other', 0.9974651030075826)]",['B.1.112'],[0.9974651],0.6090439953290001 +SRR13297857,SRR13297857,B.1.450,20C,51105,51105,25421,49.7427,372.05,99.6756,26404,387.4,388.3,4,0,0,3192,0,26614,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,114.727901,bad,0.5,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.12,Usher placements: B.1(1/2) B.1.450(1/2),"[('Other', 0.9996290499951919)]","['B.1.450' 'B.1.360' 'B.1.597' 'B.1.431' 'B.1.513' 'B.1.306' 'B.1.1.164' + 'B.1.1.61' 'B.1.334' 'B.1.1.213' 'B.1.1.142' 'B.1.557' 'B.1.1.378' + 'B.1.462' 'N.7' 'B.1.433']","[0.664336 0.29961458 0.00455581 0.00371747 0.0037037 0.00362319 + 0.00303951 0.00277008 0.0022779 0.00226757 0.00220264 0.0019305 + 0.00167159 0.00131579 0.00131406 0.00128866]",1.082816574634727 +SRR12733606,SRR12733606,B.1.390,20A,776002,776002,653607,84.2275,636.733,99.9799,29273,203.4,204.3,7,0,0,614,1,29282,29897,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,2.352483,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.390(1/1),"[('Other', 0.9985894800002555)]",['B.1.390' 'B.1.557'],[0.997249 0.00134048],1.3111670291400404 +SRR16298173,SRR16298173,B,19A,138431,138431,125512,90.6676,993.646,93.4455,25104,166.8,167.0,0,1,1,4733,1,25104,29838,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,270.567750,bad,0.5,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.17,Usher placements: B(2/4) B.51(1/4) B.6(1/4),"[('Other', 0.9982667019940928)]",['B' 'B.10' 'B.57' 'B.11'],[0.99311365 0.00300752 0.0010929 0.00105263],0.4794874213620607 +SRR16298166,SRR16298166,,,6343,6343,69,1.08781,0.00344447,0.344447,0,100.0,0.0,0,98,98,7101,0,0,7101,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,,,,,,,,,[],[],[],4.1425812798300395e-13 +SRR13689874,SRR13689874,B.1.1.512,20B,301254,301254,291105,96.6311,2601.95,99.8896,29512,224.9,225.1,27,0,0,389,0,29513,29902,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,21.115600,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.1.512(1/1),"[('Other', 0.9984619999996437)]",['B.1.1.512'],[0.998462],5.739059699133654 +SRR13422799,SRR13422799,B.1.429,21C (Epsilon),76082,76082,72210,94.9108,954.433,99.8462,29253,381.3,382.2,31,0,1,638,0,29253,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,5.907411,good,0.0,,Epsilon (B.1.429-like),1.0,0.0,scorpio call: Alt alleles 14; Ref alleles 0; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.429(1/1),"[('Epsilon', 0.9988139999990485)]",['B.1.429'],[0.998814],9.506507932009322 +SRR12192434,SRR12192434,B.1.336,20C,22164,22164,18803,84.8358,149.7,99.9599,25339,189.6,190.9,4,0,0,4352,0,25539,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,225.222277,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.15,Usher placements: B.1.336(4/4),"[('Other', 0.9999999999914736)]",['B.1.336' 'B.1.333'],[0.994253 0.005747],1.449546776376567 +SRR16298157,SRR16298157,,,1691,1691,48,2.83856,0,0,0,0.0,0.0,0,98,98,0,0,0,0,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,,,,,,,,,,,, +SRR13511054,SRR13511054,B.1.526,21F (Iota),102908,102908,98829,96.0363,1368.17,99.7693,29795,383.9,384.5,22,0,0,29,0,29795,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,2.777778,good,0.0,,Iota (B.1.526-like),0.83,0.17,scorpio call: Alt alleles 19; Ref alleles 4; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.526(4/4),"[('Iota', 0.998442000000223)]",['B.1.526'],[0.998442],2.4611501180739337 +SRR13687078,SRR13687078,B.1.1.362,20B,33826,33826,31549,93.2685,296.485,99.5118,26782,155.2,155.6,9,0,1,3068,0,26828,29896,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,105.100466,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.11,Usher placements: B.1.1.362(2/2),"[('Other', 0.999999999999946)]",['B.1.1.362'],[1.],1.2781016034105142 +SRR13433883,SRR13433883,B.1.258.23,20A,106223,106223,103545,97.4789,892.565,99.8662,28371,275.6,275.6,25,0,3,1515,0,28378,29893,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,96.812500,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.258.23(1/1),"[('Other', 0.9999999999999977)]",['B.1.258.23'],[1.],0.4943510022446659 +SRR13004400,SRR13004400,B.1.264,20C,34961,34961,32748,93.6701,478.153,99.7659,28339,384.1,385.2,7,0,0,1472,0,28361,29833,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,18.842030,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.264(1/1),"[('Other', 0.9995227099998779)]",['B.1.264' 'B.1.320'],[0.998175 0.00134771],0.7449484252986486 +SRR13358209,SRR13358209,B.1.1.440,20B,35450,35450,32711,92.2736,299.735,99.6455,25247,151.7,152.1,6,0,3,4476,0,25321,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,239.217778,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.16,Usher placements: B.1.1.440(1/1),"[('Other', 0.9999999999997261)]",['B.1.1.440'],[1.],0.37655257754829174 +SRR12833718,SRR12833718,B.1.1.174,20B,651160,651160,606671,93.1677,5205.77,97.211,27112,185.8,186.2,14,0,3,2433,8,27120,29561,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,127.972500,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.1,Usher placements: B.1.1.174(1/1),"[('Other', 0.9986144471747955)]",['B.1.1.174'],[0.99861445],2.5198505644603904 +SRR16298169,SRR16298169,Unassigned,19B,223543,223543,207555,92.8479,1460.08,91.7968,19275,145.8,159.1,3,5,14,10413,1,19312,29726,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1403.918642,bad,,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.36,,"[('A', 0.9988582479988226)]",['A'],[0.99885825],1.9567600856205867 +SRR13486908,SRR13486908,B.1.385,20A,3297513,3297513,3038569,92.1473,14336,100,29869,256.6,257.5,17,0,0,34,0,29869,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,6.250000,good,0.0,,,,,,PANGO-v1.2.133,4.0.2,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9984620435063583)]",['B.1.385'],[0.99846204],3.620952693076005 +SRR13690340,SRR13690340,B.1.232,20A,333889,333889,301041,90.162,2691.74,100,29576,200.3,200.4,18,0,0,327,1,29575,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,7.260000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.232(1/1),"[('Other', 0.9943996580042727)]",['B.1.232' 'B.1.2' 'B.1.383' 'B.1.382'],[0.720549 0.27023337 0.00258953 0.00102775],2.5862526843447418 +SRR11577968,SRR11577968,B.1.320,20C,436687,436687,433315,99.2278,3908.91,99.7693,29624,254.3,254.5,7,0,0,207,0,29627,29834,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.320(1/1),"[('Other', 0.992723891019766)]",['B.1.320'],[0.99272389],0.6609690453040331 +SRR13195052,SRR13195052,B.1.1.139,20B,416419,416419,387426,93.0375,3289.94,99.9732,29621,195.8,196.2,10,0,0,269,0,29633,29902,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.139(1/1),"[('Other', 0.9981757570085352)]",['B.1.1.139'],[0.99817576],0.9304229541818549 +SRR13500958,SRR13500958,P.2,20B,73899,73899,69791,94.4411,964.395,99.7659,28015,379.9,381.4,22,0,0,1797,0,28036,29833,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,30.740864,mediocre,0.0,,Zeta (P.2-like),0.86,0.14,scorpio call: Alt alleles 6; Ref alleles 1; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: P.2(1/1),"[('Zeta', 0.9999999999989699)]",['P.2'],[1.],2.2156887583671367 +SRR13193342,SRR13193342,B.1,20C,78530,78530,74227,94.5206,1060.37,99.7759,29310,565.5,561.0,10,0,0,509,0,29327,29836,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.599191,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1(1/1),"[('Other', 0.9981853259988552)]",['B.1.320'],[0.99818533],2.116845179402226 +ERR5771988,ERR5771988,B.1.617.1,21B (Kappa),1111192,1111192,1107889,99.7028,13336.6,99.7826,29512,391.6,391.7,28,1,1,2618,0,27253,29871,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,73.705405,mediocre,0.0,,B.1.617.1-like,0.91,0.0,scorpio call: Alt alleles 10; Ref alleles 0; Amb alleles 1; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.1,Usher placements: B.1.617.1(1/1),"[('Kappa', 0.9997299999981215)]",['B.1.617.1'],[0.99973],1.1430132476192507 +SRR16298174,SRR16298174,,,148231,148231,134328,90.6207,0.360766,19.2355,0,62.3,127.6,0,98,98,29440,0,0,29440,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,,,,,,,,,"[('Other', 0.8936170212649831), ('A', 0.10638297872328144)]","['B' 'B.41' 'B.18' 'B.3' 'B.30' 'B.40' 'B.37' 'B.32' 'B.34' 'B.3.1' 'A.2' + 'B.60' 'B.39' 'B.35' 'A.5' 'B.43' 'A.24' 'A.26' 'A.25' 'A.2.3' 'A.11' + 'A.21' 'A.19' 'B.29' 'B.58' 'B.33' 'B.52' 'B.26' 'B.61' 'B.27' 'B.1.14' + 'B.20' 'B.15' 'B.19' 'B.1.1.161' 'B.6' 'B.47' 'B.23' 'B.57' 'B.12' 'B.28' + 'B.51' 'B.13' 'A' 'B.45' 'B.42' 'B.10' 'B.1.1.306' 'B.1.1.447' + 'B.1.1.175' 'B.1.1.172' 'B.1.1.376' 'B.1.1.203' 'B.1.1.500' 'B.1.1.121' + 'B.1.1.364' 'B.1.1.187' 'B.1.1.441' 'B.1.1.122' 'B.1.1.398' 'B.1.1.164' + 'B.1.1.137' 'B.1.1.134' 'B.1.1.59' 'B.1.1.367' 'B.1.1.118' 'B.1.1.148' + 'B.1.1.26' 'B.1.1.485' 'B.1.1.25' 'B.1.1.440' 'B.1.1.463' 'B.1.1.129' + 'B.1.1.57' 'B.1.1.10' 'B.1.1.378' 'B.1.350' 'B.1.267' 'B.1.108' 'B.1.39' + 'B.1.329' 'B.1.330' 'B.1.333' 'B.1.431' 'B.1.483' 'B.1.479' 'B.1.37' + 'B.1.13' 'B.1.274' 'B.1.277' 'B.1.210' 'B.1.214' 'B.1.231' 'B.1.408' + 'B.1.489' 'B.1.487' 'B.1.115' 'B.1.1.33' 'B.1.323' 'B.1.38' 'B.1.413' + 'B.1.360' 'B.1.321' 'B.1.166' 'B.1.319' 'B.1.513' 'B.1.520' 'B.1.510' + 'B.1.320' 'B.1.324' 'B.1.453' 'B.1.302' 'B.1.167' 'B.1.1.43' 'B.1.96' + 'B.1.1.180' 'B.1.205' 'B.1.543' 'B.1.220' 'B.1.178' 'B.1.213' 'B.1.6' + 'B.1.151' 'B.1.35' 'B.1.1.274' 'B.1.384' 'B.1.23' 'B.1.198' 'B.1.93' + 'B.1.69' 'B.1.206' 'B.1.137' 'B.1.194' 'B.1.70' 'B.1.199' 'B.1.545' + 'B.1.78' 'B.1.145' 'B.1.142' 'B.1.383' 'B.1.395' 'B.1.201' 'B.1.81' + 'B.1.8' 'B.1.215' 'B.1.76' 'B.1.67' 'B.1' 'B.1.222' 'B.1.379' 'B.1.182' + 'B.1.229' 'B.1.1.166' 'B.1.1.34' 'B.1.1.192' 'B.1.1.205' 'B.1.1.189' + 'B.1.1.71' 'B.1.1.142' 'B.1.1.95' 'B.1.401' 'B.1.399' 'B.1.558' 'B.1.238' + 'B.1.397' 'B.1.239' 'B.1.233' 'B.1.180' 'B.1.416' 'B.1.600' 'B.1.546' + 'B.1.393' 'B.1.153' 'B.1.551' 'B.1.382' 'B.1.1' 'B.1.415' 'B.1.181' + 'B.1.420' 'B.1.609' 'B.1.225' 'B.1.223' 'B.1.407' 'B.1.1.219' 'B.1.402' + 'B.1.1.13' 'B.1.1.194' 'B.1.1.38' 'B.1.1.208' 'B.1.1.165' 'B.59' 'N.4' + 'N.3' 'N.1' 'N.2' 'N.6' 'N.9' 'B.1.1.61' 'B.1.1.256' 'B.1.1.86' + 'B.1.1.308' 'B.1.1.239' 'B.1.1.89' 'B.1.533' 'B.1.1.354' 'B.1.1.125' + 'B.1.1.326' 'B.1.1.368' 'B.1.597' 'B.1.332' 'B.1.293' 'B.1.342' 'B.1.372' + 'B.1.12' 'B.1.356' 'B.1.340' 'B.1.40' 'B.1.492' 'B.1.554' 'B.1.276' + 'B.1.524' 'B.1.97' 'B.1.416.1' 'B.1.403' 'B.1.610' 'B.1.241' 'B.1.405' + 'B.1.1.432' 'L.2' 'B.1.1.236' 'B.1.1.209' 'B.1.1.243' 'B.1.1.482' + 'B.1.574' 'B.1.165' 'B.1.521' 'B.1.435' 'B.1.605' 'B.1.409' 'B.1.1.269' + 'B.1.1.190' 'B.1.1.227' 'B.1.532' 'B.1.1.207' 'D.4' 'B.1.1.453' 'AV.1' + 'B.1.1.44' 'B.1.445' 'B.1.375' 'B.1.1.351' 'B.1.1.182' 'D.5' 'B.1.314' + 'B.1.1.50' 'B.1.1.226' 'B.1.1.139' 'B.1.1.428' 'AE.1' 'AE.6' 'B.1.548' + 'B.1.576' 'B.1.346' 'N.8' 'B.1.426' 'B.1.448' 'B.1.596.1' 'B.1.578' + 'B.1.1.171' 'B.1.1.216' 'B.1.1.170' 'N.5' 'B.1.22' 'B.1.116' 'B.1.370' + 'B.1.336' 'B.1.1.356' 'B.1.1.107' 'B.1.1.307' 'B.1.1.300' 'B.1.1.514' + 'B.1.1.301' 'B.1.1.70' 'B.1.1.116' 'B.1.1.67' 'D.3' 'B.1.1.217' + 'B.1.1.141' 'B.1.1.280' 'B.1.1.506' 'B.1.560' 'B.1.1.46' 'B.1.1.487' + 'B.1.1.416' 'B.1.1.228' 'B.1.1.309' 'B.1.1.310' 'B.1.1.37' 'B.1.1.14' + 'B.1.236' 'B.1.530' 'B.1.1.297' 'B.1.1.404' 'B.1.1.8' 'B.1.1.423' + 'B.1.1.17' 'B.1.1.63' 'B.1.1.258' 'B.1.1.41' 'B.1.1.261' 'B.1.1.253' + 'B.1.1.82' 'B.1.1.270' 'B.1.1.249' 'B.1.1.421' 'B.1.1.133' 'B.1.1.115' + 'B.1.1.58' 'B.1.1.325' 'B.1.1.380' 'B.1.355' 'B.1.1.408' 'B.1.287' + 'B.1.515' 'B.1.298' 'B.1.366' 'B.1.117' 'B.1.304' 'B.1.452' 'B.1.451' + 'B.1.1.149' 'B.1.334' 'B.1.289' 'B.1.310' 'B.1.586' 'B.1.424' 'B.1.450' + 'B.1.301' 'B.1.265' 'B.1.1.374' 'B.1.1.365' 'B.1.1.362' 'B.1.1.285' + 'B.1.1.395' 'B.1.1.244' 'B.1.1.111' 'B.1.1.345' 'B.1.1.263' 'B.1.1.312' + 'B.1.1.114' 'B.1.1.113' 'B.1.1.162' 'B.1.1.360' 'B.1.1.210' 'B.1.1.48' + 'B.1.1.49' 'B.1.1.283' 'B.1.1.51' 'B.1.1.144' 'B.1.1.98' 'B.1.1.379' + 'B.1.235']","[0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873]",0.5000000000069557 +SRR13668148,SRR13668148,B.1.570,20C,200629,200629,161505,80.4993,1492.37,98.9901,23317,154.4,155.4,10,0,0,6548,0,23346,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,535.493882,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.22,Usher placements: B.1.570(1/1),"[('Other', 0.9982710000000012)]",['B.1.570'],[0.998271],0.40891938275289097 +SRR13526755,SRR13526755,B.1.1.418,20B,1068040,1068040,968596,90.6891,8293.36,99.8997,29782,179.7,179.9,18,0,0,91,0,29782,29873,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.418(1/1),"[('Other', 0.9987200000023091)]",['B.1.1.418'],[0.99872],0.6667989871522338 +SRR16298163,SRR16298163,,,162,162,136,83.9506,0.970204,40.3739,0,123.1,125.1,0,98,98,29677,0,0,29677,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,,,,,,,,,"[('Other', 0.9999999999986484)]","['B.1.36.38' 'B.1.320' 'B.1.431' 'B.1.39' 'B.1.489' 'B.1.302' 'B.1.453' + 'B.1.572' 'B.1.324' 'B.1.510' 'B.1.570' 'B.1.344' 'B.1.520' 'B.1.513' + 'B.1.319' 'B.1.321' 'B.1.413' 'B.1.294' 'B.1.437' 'B.1.428' 'B.1.298' + 'B.1.304' 'B.1.428.3' 'B.1.428.1' 'B.1.491' 'B.1.44' 'B.1.314' 'B.1.576' + 'B.1.533' 'B.1.40' 'B.1.340' 'B.1.582' 'B.1.349' 'B.1.22' 'B.1.586' + 'B.1.362' 'B.1.334' 'B.1.267']","[0.03656824 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 ]",2.493450309757139 +SRR16298162,SRR16298162,,,15303,15303,3518,22.989,15.7096,99.1707,0,124.0,127.2,0,3,92,29782,0,0,29782,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,,,,,,,,,"[('Other', 0.9999999999707732)]",['B.1.400.1' 'B' 'B.1' 'B.1.399'],[0.352941 0.333333 0.254902 0.058824],4.4173170009420994 +SRR13603869,SRR13603869,B.1.427,21C (Epsilon),35473,35473,33496,94.4267,316.52,98.3982,24179,156.6,156.8,14,1,5,5657,0,24192,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,393.654993,bad,0.0,,Epsilon (B.1.427-like),0.62,0.0,scorpio call: Alt alleles 8; Ref alleles 0; Amb alleles 5; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.2,Usher placements: B.1.427(10/10),"[('Epsilon', 0.9999999999999837)]",['B.1.427'],[1.],2.1333243393292336 +SRR16298167,SRR16298167,,,1330,1330,96,7.21805,0.0167207,1.21393,0,363.0,363.0,0,98,98,363,0,0,363,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,,,,,,,,,[],[],[],6.666422494759199e-12 +SRR13129709,SRR13129709,D.3,20B,568486,568486,555853,97.7778,4611.04,99.8328,29547,215.9,216.2,14,0,0,304,0,29549,29853,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000219,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: D.3(1/1),"[('Other', 0.9957973393754935)]",['D.3'],[0.99579734],0.7540556101956113 +ERR5181310,ERR5181310,B.1.525,21D (Eta),912571,912571,909776,99.6937,10999.1,99.6154,29734,391.7,391.9,35,0,0,67,0,29732,29799,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,Eta (B.1.525-like),1.0,0.0,scorpio call: Alt alleles 16; Ref alleles 0; Amb alleles 0; Oth alleles 0,PANGO-v1.2.133,4.0.2,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Eta', 0.9995440000019115)]",['B.1.525'],[0.999544],6.0230211922291605 +SRR11915959,SRR11915959,B.35,19A,553601,553601,542581,98.0094,4599.47,99.8529,28759,235.3,235.7,8,0,1,1105,5,28756,29866,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,33.889232,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: B.35(1/1),"[('Other', 0.9868019551687629)]",['B.35'],[0.98680196],8.133502169006327 +SRR12661075,SRR12661075,B.1.452,20C,3399069,3399069,3018507,88.8039,26574.4,100,29815,187.6,187.7,8,0,0,88,0,29815,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.2,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9865538134609476)]",['B.1.452'],[0.98655381],0.5219594381346055 +SRR13422802,SRR13422802,B.1.427,21C (Epsilon),146635,146635,139244,94.9596,1865.65,99.3445,29363,382.9,383.8,19,0,0,443,0,29363,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.280508,good,0.0,,Epsilon (B.1.427-like),0.92,0.0,scorpio call: Alt alleles 12; Ref alleles 0; Amb alleles 1; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.427(1/1),"[('Epsilon', 0.998269999996965)]",['B.1.427'],[0.99827],2.5932039829313354 +SRR16298165,SRR16298165,Unassigned,19B,533855,533855,499859,93.632,3900.34,43.3134,10764,158.6,158.8,6,48,46,16112,0,10770,26882,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3429.620631,bad,,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.64,,"[('Other', 0.9903667149857094)]",['B.1.1.348'],[0.99036671],2.8796572563497858 +SRR12774785,SRR12774785,B.1.287,20C,29696,29696,27583,92.8846,250.013,98.8663,24539,150.6,150.9,7,0,4,5293,1,24597,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,342.975981,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.19,Usher placements: B.1.287(1/1),"[('Other', 1.0000000000000215)]",['B.1.287' 'B.1.319' 'B.1.324'],[0.993243 0.00505051 0.00170649],0.4394224647772782 +SRR13297853,SRR13297853,B.1.323,20C,372300,372300,316829,85.1005,4575,99.9197,29805,535.7,533.3,7,0,0,74,0,29805,29879,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.2,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9941779379912073)]",['B.1.323'],[0.99417794],0.5776928122749417 +SRR12530461,SRR12530461,B.1.1.431,20B,584532,584532,575787,98.5039,4994.48,99.4649,27617,239.2,239.7,16,0,1,2247,0,27617,29864,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,52.000123,mediocre,0.5,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.09,Usher placements: B.1.1(1/2) B.1.1.431(1/2),"[('Other', 0.9703939810747845)]","['B.1.1.213' 'B.1.1.402' 'B.1.1.174' 'B.1.1.274' 'B.1.1.192' 'B.1.1.283' + 'B.1.1.89' 'B.1.1.194' 'B.1.1.43' 'B.1.533']","[0.91415241 0.02718763 0.00891243 0.00854701 0.00294768 0.00242256 + 0.00201342 0.00182306 0.00131349 0.0010743 ]",3.577584903254084 +SRR16298164,SRR16298164,,,37159,37159,36931,99.3864,0.0650102,4.07651,0,166.6,176.8,0,98,98,29849,0,0,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,,,,,,,,,,,, +SRR13606410,SRR13606410,P.2,20B,92107,92107,87333,94.8169,1219.75,99.7358,29805,381.5,383.0,20,0,0,19,0,29805,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,Zeta (P.2-like),0.86,0.14,scorpio call: Alt alleles 6; Ref alleles 1; Amb alleles 0; Oth alleles 0,PANGO-v1.2.133,4.0.2,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Zeta', 0.9987559999999484)]",['P.2'],[0.998756],2.281432791659655 +SRR13690003,SRR13690003,B.1,20G,753605,753605,706369,93.732,6275.35,99.9632,29597,198.1,198.3,18,0,0,296,7,29590,29893,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,53.340278,mediocre,0.5,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1(1/2) B.1.2(1/2),"[('Other', 0.8977417300595328), ('Epsilon', 0.09303430966351274)]",['B.1.2' 'B.1.550' 'B.1.427'],[0.67683973 0.220902 0.09303431],5.808671478208372 +SRR13089080,SRR13089080,B.1.589,20C,37630,37630,26337,69.9894,381.88,99.7358,28855,403.9,402.7,9,0,0,900,0,28924,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,4.938272,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: B.1.589(1/1),"[('Other', 1.0000000000006435)]",['B.1.589' 'B.1.306' 'B.1.37' 'B.1.22' 'B.1.81' 'B.1.439'],[0.99215791 0.00246609 0.00161031 0.00156908 0.00110132 0.00109529],0.6837990260814789 +ERR5405022,ERR5405022,B.1.1.7,"20I (Alpha, V1)",154545,154545,151242,97.8628,1236.53,99.7525,28291,182.4,182.9,35,0,0,1512,0,28300,29812,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,20.150123,good,0.0,,Alpha (B.1.1.7-like),0.96,0.04,scorpio call: Alt alleles 22; Ref alleles 1; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.07,Usher placements: B.1.1.7(4/4),"[('Alpha', 0.9994305239977794)]",['Q.1'],[0.99943052],6.23424681110291 +SRR12901576,SRR12901576,B.1,20C,363267,363267,354907,97.6987,3151.37,99.3914,28880,254.8,254.7,7,0,0,1012,0,28888,29900,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,6.953964,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: B.1(1/1),"[('Other', 0.9894937379980409)]",['B.1.515' 'B.1.372' 'B.1.306' 'B.1.298'],[0.98271264 0.00309598 0.00262467 0.00106045],1.605234296209766 +SRR13574337,SRR13574337,B.1.375,20C,1245538,1245538,1053080,84.5482,1554.99,99.9933,29827,284.4,285.4,15,0,0,71,0,29826,29897,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.2,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9974950820017968)]",['B.1.375' 'B.1.306'],[0.996375 0.00112008],1.5318447613638648 +SRR12833927,SRR12833927,B.1.1.514,20B,1287220,1287220,1210340,94.0274,10624,98.7493,29470,190.6,190.8,8,0,1,88,0,29473,29561,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.514(1/1),"[('Other', 0.9956199999981679)]",['B.1.1.514'],[0.99562],0.5887335846335993 +ERR5749609,ERR5749609,Unassigned,21J (Delta),2323723,2323723,2315943,99.6652,27728,99.9833,29729,391.3,391.4,26,0,0,10326,1,19567,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1379.884444,bad,,,Delta (B.1.617.2-like),0.69,0.0,scorpio call: Alt alleles 9; Ref alleles 0; Amb alleles 4; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.36,,"[('Delta', 0.990006062828753)]",['AY.46' 'AY.46.1'],[0.98859024 0.00141582],2.50549594192071 +ERR5743043,ERR5743043,Unassigned,21J (Delta),1890053,1890053,1883051,99.6295,22727.6,99.99,29639,391.8,391.9,26,0,0,9105,0,20789,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1063.484568,bad,,,Delta (B.1.617.2-like),0.69,0.0,scorpio call: Alt alleles 9; Ref alleles 0; Amb alleles 4; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.32,,"[('Delta', 0.9894888314014936)]",['AY.1' 'AY.46.1'],[0.98787827 0.00161056],2.342570902566065 +ERR5743893,ERR5743893,B.1.617.1,21B (Kappa),198314,198314,166710,84.0637,1821.9,98.8095,27600,386.5,386.8,23,1,1,2246,0,27626,29872,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,51.946722,mediocre,0.0,,B.1.617.1-like,1.0,0.0,scorpio call: Alt alleles 11; Ref alleles 0; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: B.1.617.1(6/6),"[('Kappa', 0.9999999999997385)]",['B.1.617.1'],[1.],1.198380375868782 +ERR5691945,ERR5691945,B.1.351,"20H (Beta, V2)",1735046,1735046,1723717,99.347,20605.5,99.9766,29569,390.9,391.2,23,0,1,7666,0,22215,29881,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,744.279232,bad,0.0,,Beta (B.1.351-like),0.79,0.0,scorpio call: Alt alleles 11; Ref alleles 0; Amb alleles 1; Oth alleles 2,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.27,Usher placements: B.1.351(2/2),"[('Beta', 0.9987345108397899)]",['B.1.351'],[0.99873451],5.557750812666864 +SRR16298160,SRR16298160,Unassigned,20A,14341,14341,13508,94.1915,108.457,95.7295,11093,173.5,173.8,5,8,38,18527,0,11177,29704,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,4557.250055,bad,,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.63,,"[('Other', 0.9999999999986925)]",['B.1.243'],[1.],1.4061221334758691 +SRR16298175,SRR16298175,Unassigned,19A,142646,142646,132133,92.63,170.294,59.7331,6164,155.9,156.4,2,53,66,23682,0,6167,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,7499.560000,bad,,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.79,,"[('Other', 0.9936264669502398)]","['B.1.390' 'B.1.1.261' 'B.1.165' 'B.1.110' 'B.1.323' 'B.1.413' 'B.1.513' + 'B.1.510' 'B.1.572' 'B.1.453' 'B.1.268' 'B.1.489' 'B.1.350' 'B.1.161' + 'B.1.473' 'B.1.287' 'B.1.428' 'B.1.117' 'B.1.314' 'B.1.199' 'B.1.6' + 'B.1.143' 'B.1.379' 'B.1.182' 'B.1.180' 'B.1.223' 'B.1.225' 'B.1.145' + 'B.1.201' 'B.1.609' 'B.1.96' 'B.1.8' 'B.1.134' 'B.1.215' 'B.1.67' + 'B.1.210' 'B.1' 'B.1.378' 'B.1.402' 'B.1.428.1' 'B.1.346' 'B.1.110.1' + 'B.55' 'B.1.1.37' 'B.1.1.283' 'B.1.310' 'B.1.39' 'B.1.1.175' 'B.1.1.384' + 'B.1.1.351' 'B.1.415']","[0.041841 0.03312847 0.02816748 0.02816748 0.02816748 0.02816748 + 0.02816748 0.02816748 0.02816748 0.02816748 0.02816748 0.02816748 + 0.02816748 0.02816748 0.02816748 0.02816748 0.02816748 0.02816748 + 0.02816748 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 + 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 + 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 + 0.02105164 0.02105164 0.00854701 0.00517627 0.00517356 0.0046729 + 0.00264317 0.00257732 0.00252525 0.0020202 0.00170358 0.00140647 + 0.00114943 0.0011274 0.00110619]",2.107131994924186 +ERR5181360,ERR5181360,B.1.525,21D (Eta),1500457,1500457,1492260,99.4537,17923,99.8361,29746,398.8,398.5,32,0,0,2195,0,27633,29828,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,49.259602,mediocre,0.0,,Eta (B.1.525-like),0.94,0.0,scorpio call: Alt alleles 15; Ref alleles 0; Amb alleles 1; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.09,Usher placements: B.1.525(8/8),"[('Eta', 0.9994976652554511)]",['B.1.525'],[0.99949767],6.485208364316353 +SRR13126740,SRR13126740,B.1.384,20A,33706,33706,31563,93.6421,283.858,97.6257,21822,152.3,152.9,4,0,10,7916,0,21880,29796,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,795.657833,bad,0.14285714285714285,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.28,Usher placements: B.1(1/7) B.1.384(6/7),"[('Other', 0.9999999999999798)]",['B.1.384'],[1.],0.4250702074217659 +SRR13195265,SRR13195265,B.1.1.205,20B,1946500,1946500,1035164,53.1808,7529.44,99.5954,29567,134.7,135.9,9,0,0,194,0,29588,29782,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.205(1/1),"[('Other', 0.9879382599984355)]",['B.1.1.205' 'B.1.1.197' 'B.1.1.92' 'B.1.1.71'],[0.982222 0.00250878 0.00175029 0.00145719],0.8927006760053333 +SRR13195337,SRR13195337,B.1.309,20C,2277602,2277602,1320912,57.9957,9910.91,99.6489,29782,143.4,144.3,14,0,0,16,0,29782,29798,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.2,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9903760000002543)]",['B.1.309'],[0.990376],0.8957858223202387 +SRR16298159,SRR16298159,,,27131,27131,21036,77.5349,0.253821,15.266,0,93.6,151.4,0,98,98,29069,0,0,29069,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,,,,,,,,,"[('Other', 0.9978354978326749), ('Zeta', 0.002164502164496045)]","['AZ.4' 'B.1.1.174' 'B.1.1.129' 'B.1.1.57' 'B.1.1.10' 'B.1.1.398' + 'B.1.1.441' 'B.1.1.447' 'B.1.1.175' 'B.1.1.376' 'B.1.1.203' 'B.1.1.500' + 'B.1.1.275' 'B.1.267' 'B.1.315' 'B.1.115' 'B.1.323' 'B.1.294' 'B.1.564' + 'B.1.413' 'B.1.264' 'B.1.321' 'B.1.166' 'B.1.319' 'B.1.513' 'B.1.520' + 'B.1.344' 'B.1.1.185' 'B.1.1.402' 'B.1.320' 'B.1.1.169' 'B.1.1.192' + 'B.1.1.34' 'B.1.1.254' 'B.1.1.166' 'B.1.1.274' 'B.1.1.83' 'B.1.1.372' + 'B.1.1.33' 'B.1.1.43' 'B.1.1.122' 'B.1.1.164' 'B.1.1.200' 'B.1.1.137' + 'B.1.173' 'B.1.1.134' 'B.1.1.118' 'B.1.1.148' 'B.1.1.12' 'B.1.1.168' + 'B.1.1.26' 'B.1.1.485' 'B.1.1.25' 'B.1.1.378' 'B.1.1.440' 'B.1.1.438' + 'B.1.510' 'B.1.485' 'B.1.1.189' 'B.1.530' 'B.1.1.75' 'B.1.1.5' + 'B.1.1.222' 'B.1.1.317' 'B.1.1.220' 'B.1.1.158' 'B.1.1.464' 'B.1.1.8' + 'B.1.1.423' 'B.1.1.17' 'B.1.1.257' 'B.1.1.323' 'B.1.1.458' 'B.1.1.63' + 'B.1.1.45' 'B.1.1.14' 'B.1.1.384' 'B.1.1.130' 'B.1.1.261' 'B.1.1.241' + 'B.1.1.253' 'B.1.1.82' 'B.1.1.204' 'B.1.1.133' 'B.1.1.115' 'B.1.1.404' + 'B.1.232' 'B.1.324' 'B.1.235' 'B.1.572' 'B.1.268' 'B.1.487' 'B.1.108' + 'B.1.489' 'B.1.39' 'B.1.329' 'B.1.330' 'B.1.333' 'B.1.431' 'B.1.511' + 'B.1.483' 'B.1.479' 'B.1.13' 'B.1.274' 'B.1.277' 'B.1.273' 'B.1.478' + 'B.1.139' 'B.1.565' 'B.1.210' 'B.1.408' 'B.1.407' 'B.1.551' 'B.1.402' + 'B.1.1.205' 'B.1.1.71' 'AZ.3' 'B.3.1' 'B.60' 'B.39' 'B.35' 'B.6.6' + 'B.1.67' 'B.1.76' 'B.1.215' 'B.1.8' 'B.1.81' 'B.1.201' 'B.1.395' + 'B.1.383' 'B.1.142' 'B.1.145' 'B.1.143' 'B.1.78' 'B.1.195' 'B.1.134' + 'B.1.545' 'B.1.378' 'B.1.199' 'B.1.91' 'B.1.179' 'B.1.70' 'B.1.377' 'B.1' + 'B.34' 'B.1.194' 'B.32' 'B.15' 'B.20' 'B.1.14' 'B.27' 'B.55' 'B.26' + 'B.23' 'B.6' 'B.47' 'B.57' 'B.11' 'B.10' 'B.42' 'B.45' 'B.12' 'B.28' + 'B.61' 'B.33' 'B.41' 'B.29' 'B.3' 'B.30' 'B.31' 'B.40' 'B.37' 'B.1.187' + 'B.1.543' 'B.1.1.142' 'B.1.248' 'B.1.250' 'B.1.1' 'B.1.382' 'B.1.219' + 'B.1.96' 'B.1.153' 'B.1.393' 'B.1.416' 'B.1.233' 'B.1.229' 'B.1.556' + 'B.1.381' 'B.1.243' 'B.1.239' 'B.1.397' 'B.1.400' 'B.1.238' 'B.1.558' + 'B.1.399' 'B.1.401' 'B.1.240' 'B.1.249' 'B.1.254' 'B.1.252' 'B.1.1.92' + 'B.1.251' 'B.1.104' 'B.58' 'B.1.391' 'B.43' 'B.1.103' 'B.1.178' 'B.1.147' + 'B.1.213' 'B.1.6' 'B.1.151' 'B.1.208' 'B.1.218' 'B.1.205' 'B.1.35' + 'B.1.23' 'B.1.198' 'B.1.390' 'B.1.106' 'B.1.379' 'B.1.182' 'B.1.180' + 'B.1.223' 'B.1.225' 'B.1.420' 'B.1.181' 'B.1.418' 'B.1.415' 'B.1.559' + 'B.1.1.41' 'B.1.1.231' 'B.1.1.310' 'B.1.164' 'B.1.466' 'B.1.456' 'B.1.36' + 'B.1.184' 'B.1.627' 'B.1.398' 'B.1.1.4' 'B.1.1.216' 'B.1.1.29' 'P.7' + 'AH.1' 'AH.2' 'B.1.1.467' 'B.1.1.294' 'B.1.1.344' 'B.1.1.482' 'B.1.1.322' + 'B.1.428.1' 'B.1.428.2' 'B.1.165' 'B.1.521' 'B.1.435' 'B.1.433' 'B.1.9' + 'B.1.443' 'B.1.170' 'B.1.162' 'B.1.36.24' 'B.1.245' 'B.1.1.308' + 'B.1.1.311' 'B.1.1.16' 'B.1.1.239' 'B.1.1.89' 'B.1.1.315' 'B.1.533' + 'B.1.1.136' 'B.1.1.13' 'L.2' 'B.1.1.214' 'B.1.1.226' 'B.1.1.363' + 'B.1.1.373' 'B.1.494' 'B.1.571' 'B.1.120' 'B.1.579' 'B.1.314' 'B.1.448' + 'B.1.596.1' 'B.1.112' 'B.1.439' 'B.1.161' 'B.1.124' 'B.1.36.7' + 'B.1.36.35' 'B.1.1.107' 'B.1.428.3' 'B.1.441' 'B.1.385' 'B.1.9.1' + 'B.1.9.2' 'B.1.9.4' 'B.1.9.5' 'B.1.36.34' 'B.1.36.12' 'B.1.221' + 'B.1.1.348' 'C.23' 'C.36' 'B.1.1.375' 'M.2' 'B.1.1.236' 'AF.1' 'B.1.389' + 'B.1.1.290' 'B.1.400.1' 'B.1.1.277' 'B.1.1.303' 'B.1.562' 'B.1.221.1' + 'B.1.1.318' 'XB' 'B.1.570' 'B.1.564.1' 'B.1.36.8' 'L.4' 'B.1.36.16' + 'B.1.36.1' 'B.1.469' 'B.1.214.3' 'B.1.409' 'B.1.1.523' 'P.6' 'P.2' 'C.35' + 'C.13' 'C.12' 'C.27' 'C.25' 'C.3' 'C.14' 'C.1' 'C.4' 'C.32' 'C.2' + 'B.1.1.269' 'B.1.1.190' 'B.1.1.207' 'B.1.1.161' 'D.4' 'B.1.1.44' + 'B.1.1.159' 'B.1.1.97' 'AN.1' 'B.1.1.210' 'B.1.1.305' 'B.1.1.49' + 'B.1.1.51' 'B.1.1.98' 'B.1.1.379' 'B.1.1.360' 'B.1.1.237' 'B.1.1.365' + 'B.1.1.408' 'B.1.359' 'B.1.493' 'B.1.3' 'B.1.309' 'B.1.496' 'B.1.369' + 'B.1.287' 'B.1.428' 'B.1.515' 'B.1.298' 'B.1.366' 'B.1.304' 'B.1.264.1' + 'B.1.606' 'B.1.452' 'B.1.355' 'B.1.1.48' 'B.1.1.162' 'B.1.1.61' + 'B.1.1.285' 'B.1.1.307' 'B.1.1.116' 'B.1.1.67' 'D.3' 'B.1.1.217' + 'B.1.1.141' 'B.1.1.506' 'B.1.1.46' 'B.1.1.132' 'B.1.1.416' 'B.1.1.266' + 'B.1.1.228' 'B.1.1.58' 'B.1.1.325' 'B.1.1.380' 'B.1.1.362' 'B.1.1.244' + 'B.1.1.177' 'B.1.1.359' 'B.1.1.263' 'B.1.1.461' 'B.1.1.381' 'B.1.1.262' + 'B.1.1.213' 'B.1.1.113' 'B.1.337' 'B.1.168' 'B.1.335' 'B.1.451' 'B.1.97' + 'B.1.1.291' 'B.1.416.1' 'B.1.610' 'B.1.241' 'B.1.405' 'B.1.1.289' + 'B.1.1.459' 'B.1.1.77' 'B.1.1.521' 'B.1.1.368' 'B.1.1.326' 'B.1.1.125' + 'B.1.1.194' 'B.1.1.138' 'B.1.1.38' 'B.1.1.208' 'B.1.1.128' 'B.1.1.55' + 'B.1.1.186' 'B.1.1.1' 'B.59' 'N.4' 'N.3' 'N.1' 'B.1.159' 'B.1.281' + 'B.1.462' 'B.1.22' 'B.1.334' 'B.1.310' 'B.1.586' 'B.1.424' 'B.1.450' + 'B.1.301' 'B.1.265' 'B.1.336' 'B.1.370' 'B.1.590' 'B.1.116' 'B.1.332' + 'B.1.471' 'B.1.293' 'B.1.342' 'B.1.607' 'B.1.372' 'B.1.12' 'B.1.356' + 'B.1.340' 'B.1.492' 'B.1.465' 'B.1.470' 'B.1.523' 'B']","[0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645]",0.6309297535733255 +SRR13373851,SRR13373851,B.1.492,20C,184210,184210,169443,91.9836,1553.81,99.6455,29661,152.8,153.1,8,0,0,129,0,29668,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.492(1/1),"[('Other', 0.9992850000000023)]",['B.1.492'],[0.999285],1.1520581202898874 +SRR12751757,SRR12751757,D.2,20F,497470,497470,492069,98.9143,4292.07,97.5186,24044,210.7,211.1,14,0,3,5787,1,24061,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,413.992716,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.2,Usher placements: D.2(1/1),"[('Other', 0.999146999999873)]",['D.2'],[0.999147],2.011929144853948 +SRR16298158,SRR16298158,Unassigned,20A,300310,300310,268801,89.5078,755.487,40.4541,5484,143.4,143.9,8,68,71,24379,1,5483,29863,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,8012.149139,bad,,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.82,,"[('Other', 0.9975843876897825)]",['B.1.177.33' 'B.1.601'],[0.99657633 0.00100806],2.2757488290680765 +SRR13527262,SRR13527262,B.1.1.450,20B,209689,209689,193935,92.487,1687.27,97.4016,24644,185.8,186.0,11,1,6,5232,0,24667,29899,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,333.671111,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.19,Usher placements: B.1.1.450(1/1),"[('Other', 0.997939853000267)]",['B.1.1.450'],[0.99793985],0.44492039882487977 +SRR16298172,SRR16298172,Unassigned,19A,2604,2604,2452,94.1628,20.6813,99.7826,211,197.4,198.9,0,2,86,29617,0,221,29838,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,11789.938121,bad,,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.99,,"[('Other', 0.9999999999997088)]",['B'],[1.],1.5916110395553489 +SRR14241199,SRR14241199,B.1.526,21F (Iota),222498,222498,200666,90.1878,2842.08,99.9164,28449,385.7,385.8,25,0,0,1423,0,28449,29872,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,28.410549,good,0.0,,Iota (B.1.526-like),0.83,0.17,scorpio call: Alt alleles 19; Ref alleles 4; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.526(4/4),"[('Iota', 0.9996070000009828)]",['B.1.526'],[0.999607],3.8198925520490183 +ERR5556343,ERR5556343,P.1,"20J (Gamma, V3)",216817,216817,215689,99.4797,2590.21,99.6656,27915,385.5,385.7,32,0,0,1838,0,27964,29802,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,32.447791,mediocre,0.25,,Gamma (P.1-like),0.88,0.0,scorpio call: Alt alleles 14; Ref alleles 0; Amb alleles 0; Oth alleles 2,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: P.1(6/8) P.1.12(1/8) P.1.3(1/8),"[('Gamma', 0.9997100609955514)]",['P.1.12'],[0.99971006],1.5196978493856381 +SRR12763543,SRR12763543,B.1.1.463,20B,1236202,1236202,1093951,88.4929,9470.23,99.1941,27551,187.4,187.5,7,0,5,2340,0,27555,29895,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,57.086420,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.09,Usher placements: B.1.1.463(1/1),"[('Other', 0.9808708089987518)]",['B.1.1.463' 'B.1.1.71' 'B.1.1.231'],[0.97809008 0.00144988 0.00133085],0.6383475004073575 +SRR12162365,SRR12162365,B.1.1,20B,258545,258545,244155,94.4342,2036.28,99.6756,29564,190.6,190.9,9,0,0,242,0,29564,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1(1/1),"[('Other', 0.9829944859999504)]","['B.1.1.136' 'B.1.1.402' 'B.1.1.194' 'B.1.1.180' 'B.1.1.57' 'B.1.1.274' + 'B.1.1.148' 'B.1.1.463' 'B.1.1.92']","[0.86641818 0.10617074 0.00277932 0.00157729 0.00143266 0.00129199 + 0.00121951 0.00107066 0.00103413]",1.5339975645038009 +SRR16298168,SRR16298168,A,19B,331747,331747,299640,90.3218,2780.74,98.8229,28845,162.9,163.1,3,1,1,942,0,28855,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,5.653827,good,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: A(1/1),"[('A', 0.9987218409994785)]",['A'],[0.99872184],1.308255849188803 +SRR11494584,SRR11494584,B.4.5,19A,604651,604651,598174,98.9288,5163.91,99.7425,29782,241.0,241.3,5,0,0,44,0,29782,29826,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.2,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9970961030090059)]",['B.4.5'],[0.9970961],1.5129100209719262 +SRR16298170,SRR16298170,A,19B,606680,606680,554256,91.3589,4298.65,89.0279,24881,163.2,163.5,3,2,2,4931,0,24881,29812,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,294.186022,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.2,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.18,Usher placements: A(1/1),"[('A', 0.9924741169995949), ('Other', 0.005412719992833232)]",['A' 'B.23'],[0.99247412 0.00541272],1.5447446235311508 diff --git a/data/toggled_datasets_summary.csv b/data/toggled_datasets_summary.csv index 5e8473d..b3ad03d 100644 --- a/data/toggled_datasets_summary.csv +++ b/data/toggled_datasets_summary.csv @@ -1,75 +1,596 @@ -sample_id,sample,pangolin_lineage,nextclade_clade,vadr_p/f,fastqc_raw_reads_1,fastqc_raw_reads_2,fastp_reads_passed,depth_after_trimming,1X_coverage_after_trimming,num_pos_100X,insert_size_before_trimming,insert_size_after_trimming,ivar_num_variants_identified,bedtools_num_failed_amplicons,samtools_num_failed_amplicons,num_N,num_degenerage,num_non-ambiguous,num_total,cleaner_version,aligner_version,trimmer_version,ivar_version,vadr_model,vadr_alerts,nextclade_qc.overallScore,nextclade_qc.overallStatus,pangolin_scorpio_call,pangolin_version,pangolin_pangolin_version,pangolin_pangoLEARN_version,pangolin_pango_version,pangolin_status -SRR13373851,SRR13373851,B.1.492,20C,PASS,184210,184210,358288,1656.81,99.8428,29734,149.8,149.8,8,0,0,124,0,29743,29867,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12901576,SRR12901576,B.1.515,20C,PASS,363267,363267,716516,3331.57,99.4482,29007,257.3,257.3,7,0,0,887,0,29013,29900,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,4.726598,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298171,SRR16298171,B.1,20C,FAIL,356628,356628,705516,2656.32,94.5424,25742,155.1,155.1,33,2,4,4114,1,25764,29879,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,807.486228,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5556343,ERR5556343,P.1,"20J (Gamma, V3)",PASS,216817,216817,433046,2675.35,99.6756,28030,386.4,386.4,32,0,0,1766,0,28035,29801,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,29.480878,good,Gamma (P.1-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13689874,SRR13689874,B.1.1.512,20B,PASS,301254,301254,600498,2747.44,99.9565,29498,226.8,226.8,27,0,0,401,0,29501,29902,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,21.146876,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298167,SRR16298167,None,,,1330,1330,1058,0.0461158,3.34415,0,286.0,286.0,0,98,98,14209,0,0,14209,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,,,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR16298158,SRR16298158,None,20A,FAIL,300310,300310,591874,799.286,43.31,5526,142.1,142.2,8,66,69,24336,1,5527,29864,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,7982.206049,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13422799,SRR13422799,B.1.429,21C (Epsilon),PASS,76082,76082,148696,1086.76,99.8261,29256,383.3,383.6,31,0,1,595,0,29256,29851,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,1.193759,good,Epsilon (B.1.429-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR11577968,SRR11577968,B.1.320,20C,PASS,436687,436687,865216,4094.85,99.8361,29681,256.6,256.7,7,0,0,172,0,29682,29854,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298174,SRR16298174,None,,,148231,148231,292562,0.424941,22.3422,0,148.9,148.8,0,98,98,29441,0,0,29441,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,,,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -ERR5181310,ERR5181310,B.1.525,21D (Eta),FAIL,912571,912571,1819962,11314.8,99.6288,29711,392.6,392.6,35,0,0,94,0,29706,29800,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,DELETION_OF_FEATURE(deletins),0.000000,good,Eta (B.1.525-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298165,SRR16298165,None,20B,PASS,533855,533855,1059492,4104.92,44.7781,10935,158.5,158.6,6,46,46,15977,0,10918,26895,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,3371.307668,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -ERR5181360,ERR5181360,B.1.525,21D (Eta),PASS,1500457,1500457,2988662,18562.9,99.8763,29748,400.0,400.1,34,0,0,212,0,29665,29877,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,Eta (B.1.525-like),PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13486908,SRR13486908,B.1.385,20A,PASS,3297513,3297513,6323766,15199.4,100,29870,258.4,258.4,17,0,0,33,0,29870,29903,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,1.562500,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298162,SRR16298162,None,,,15303,15303,16538,17.0834,99.2476,0,123.3,123.9,0,2,89,29798,0,0,29798,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,,,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR16298161,SRR16298161,None,20C,FAIL,188463,188463,368960,869.357,67.0769,12782,127.9,128.0,13,24,39,16274,0,12795,29069,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,3556.506187,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13004400,SRR13004400,B.1.264,20C,PASS,34961,34961,66438,487.73,99.7726,28363,384.6,385.1,7,0,0,1434,0,28401,29835,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,17.640000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298164,SRR16298164,None,,,37159,37159,74240,0.0768485,4.21028,0,134.2,134.9,0,98,98,29849,0,0,29849,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,,,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR16298170,SRR16298170,A.1,19B,PASS,606680,606680,1197492,4602.22,90.4692,24992,162.0,162.0,3,1,2,4824,0,24993,29817,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,280.748642,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13690340,SRR13690340,B.1.232,20A,PASS,333889,333889,666534,2900.88,99.9632,29573,193.5,193.6,18,0,0,330,1,29572,29903,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,3.790123,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13126740,SRR13126740,B.1,20A,PASS,33706,33706,66504,312.998,98.0537,22433,151.1,151.1,4,0,8,7384,1,22480,29865,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,689.382112,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13297857,SRR13297857,B.1.450,20C,PASS,51105,51105,55578,381.584,99.6756,26680,388.2,388.6,4,0,0,3068,0,26738,29806,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,105.100466,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12774785,SRR12774785,B.1.287,20C,PASS,29696,29696,58340,269.187,99.0402,25000,147.7,147.7,6,0,1,4849,1,25041,29891,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,284.860096,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13690003,SRR13690003,B.1.2,20C,PASS,753605,753605,1503954,6721.78,99.9666,29618,197.7,197.7,18,0,0,275,7,29611,29893,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,49.000000,mediocre,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298169,SRR16298169,None,19B,PASS,223543,223543,442810,1527.85,91.9506,19494,157.2,157.2,3,4,14,10190,1,19536,29727,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,1342.729767,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR14241199,SRR14241199,B.1.526,21F (Iota),PASS,222498,222498,405236,3010.42,99.7994,28437,384.8,384.9,24,0,0,1394,0,28439,29833,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,16.417503,good,Iota (B.1.526-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12833718,SRR12833718,B.1.1.174,20B,PASS,651160,651160,1298520,5611.08,97.5655,27396,185.7,185.7,14,0,1,2161,8,27396,29565,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,111.681444,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5771988,ERR5771988,B.1.617.1,21B (Kappa),PASS,1111192,1111192,2219762,13813,99.7927,29490,392.3,392.3,29,1,1,383,0,29489,29872,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.094499,good,B.1.617.1-like,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13687078,SRR13687078,B.1.1.362,20B,PASS,33826,33826,66586,314.888,99.6288,27194,152.0,152.0,9,0,0,2584,0,27302,29886,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,71.559067,mediocre,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298159,SRR16298159,None,,,27131,27131,49602,0.308631,18.5232,0,149.3,149.2,0,98,98,29550,0,0,29550,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,,,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13195052,SRR13195052,B.1.1.139,20B,PASS,416419,416419,830676,3600.39,99.9799,29738,195.3,195.3,10,0,0,151,0,29751,29902,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12763543,SRR12763543,B.1.1.463,20B,PASS,1236202,1236202,2465766,10439.4,99.1907,27649,181.4,181.4,7,0,3,2245,0,27650,29895,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,51.893347,mediocre,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR11494584,SRR11494584,B.4.5,19A,PASS,604651,604651,1192916,5632.64,99.7492,29782,244.2,244.2,5,0,0,46,0,29782,29828,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13422802,SRR13422802,B.1.427,21C (Epsilon),PASS,146635,146635,287962,2100.45,99.5419,29344,384.7,384.9,19,0,0,492,0,29344,29836,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.505679,good,Epsilon (B.1.427-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12751757,SRR12751757,D.2,20F,PASS,497470,497470,984480,4591.19,97.9734,24303,214.5,214.5,14,0,2,5544,1,24309,29854,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,378.222716,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13193342,SRR13193342,B.1.578,20C,PASS,78530,78530,152804,1109.75,99.9866,29354,572.6,572.9,10,0,0,528,0,29375,29903,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.713086,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13089080,SRR13089080,B.1.589,20C,PASS,37630,37630,56160,396.898,99.7358,29110,404.4,405.1,9,0,0,705,0,29119,29824,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,2.250000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298175,SRR16298175,None,19A,PASS,142646,142646,282724,182.947,62.2011,6180,156.0,156.1,2,50,66,23681,0,6183,29864,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,7498.918532,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -ERR5743893,ERR5743893,B.1.617.1,21B (Kappa),PASS,198314,198314,396010,1936.44,98.6991,27705,386.5,386.5,23,1,1,2100,0,27705,29805,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,44.444444,mediocre,B.1.617.1-like,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13511054,SRR13511054,B.1.526,21F (Iota),PASS,102908,102908,202016,1486.93,99.8361,29772,384.9,385.1,22,0,0,72,0,29772,29844,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,Iota (B.1.526-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13129709,SRR13129709,D.3,20B,PASS,568486,568486,1112336,5076.84,99.8328,29568,218.4,218.4,14,0,0,285,0,29568,29853,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13062553,SRR13062553,B.1.265,20C,PASS,20718,20718,40946,296.319,99.8161,28023,393.2,393.9,6,0,0,1767,0,28081,29848,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,29.521111,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12212912,SRR12212912,B.1.112,20A,PASS,274115,274115,542002,2530.88,99.9565,29461,269.0,269.1,10,0,0,439,0,29464,29903,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.265034,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13500958,SRR13500958,P.2,20B,PASS,73899,73899,146510,1012.95,99.7659,28045,382.1,382.3,22,0,0,1771,0,28062,29833,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,29.682318,good,Zeta (P.2-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12733606,SRR12733606,B.1.390,20A,PASS,776002,776002,1407648,667.97,99.9231,29301,204.4,204.5,7,0,0,585,1,29311,29897,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,2.114198,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12530461,SRR12530461,B.1.1.431,20B,PASS,584532,584532,1155714,5371.18,99.5686,27717,241.3,241.3,16,0,1,2140,0,27725,29865,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,46.441701,mediocre,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13574337,SRR13574337,B.1.375,20C,PASS,1245538,1245538,2171070,1625.8,99.9967,29834,286.0,286.0,15,0,0,64,0,29833,29897,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298160,SRR16298160,None,20A,PASS,14341,14341,28322,113.449,96.1342,11528,173.3,173.6,5,7,37,18104,0,11608,29712,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,4348.181289,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR12192434,SRR12192434,B.1.336,20C,FAIL,22164,22164,42914,182.928,99.9599,28314,181.9,182.1,4,0,0,1507,1,28383,29891,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,20.984211,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298173,SRR16298173,B,19A,PASS,138431,138431,272324,1042.65,93.4053,25153,164.0,164.1,0,0,0,4682,1,25156,29839,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,264.400878,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13606410,SRR13606410,P.2,20B,PASS,92107,92107,182852,1313.67,99.7358,29782,382.8,383.0,20,0,0,42,0,29782,29824,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,Zeta (P.2-like),PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298166,SRR16298166,None,,,6343,6343,4488,0.119018,9.70471,0,151.9,151.9,0,98,98,26645,0,0,26645,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,,,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13433883,SRR13433883,B.1.258.23,20A,PASS,106223,106223,211024,959.652,99.9465,28511,280.2,280.3,25,0,3,1360,0,28537,29897,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,15.412894,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298157,SRR16298157,None,,,1691,1691,1732,0.0017724,0.0902919,0,26.5,26.5,0,98,98,18116,0,0,18116,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,,,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13527262,SRR13527262,B.1.1.450,20B,PASS,209689,209689,418656,1826.79,97.9266,24895,184.7,184.7,11,1,4,4967,0,24932,29899,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,298.777627,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13297853,SRR13297853,B.1.323,20C,PASS,372300,372300,707438,4693.56,99.9131,29782,538.9,538.9,7,0,0,67,0,29812,29879,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13526755,SRR13526755,B.1.1.418,20B,PASS,1068040,1068040,2109874,9131.92,99.8997,29794,177.2,177.2,18,0,0,79,0,29794,29873,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13603869,SRR13603869,B.1.427,21C (Epsilon),PASS,35473,35473,70064,338.536,98.7526,24349,154.7,154.7,14,0,3,5497,0,24369,29866,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,370.491207,bad,Epsilon (B.1.427-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298168,SRR16298168,A.1,19B,PASS,331747,331747,653634,2920.05,98.659,28926,157.8,157.7,3,0,1,878,0,28931,29809,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,4.582771,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13001544,SRR13001544,B.1.199,20A,PASS,152965,152965,304434,2173.23,99.8763,29782,381.4,381.5,6,0,0,84,0,29782,29866,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298172,SRR16298172,None,19A,PASS,2604,2604,5108,21.5379,99.7826,194,198.1,200.7,0,2,86,29642,0,196,29838,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,11810.054376,bad,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -SRR13668148,SRR13668148,B.1.570,20C,PASS,200629,200629,343466,1570.58,99.271,23970,151.5,151.5,9,0,0,5890,0,24004,29894,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,428.643347,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12833927,SRR12833927,B.1.1.514,20B,PASS,1287220,1287220,2567540,11353.4,98.853,29478,191.5,191.5,8,0,1,95,0,29478,29573,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13195337,SRR13195337,B.1.309,20C,PASS,2277602,2277602,4496360,14588.3,99.7425,29804,114.4,114.4,14,0,0,28,0,29798,29826,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13195265,SRR13195265,B.1.1.205,20B,PASS,1946500,1946500,3840040,11784.8,99.7191,29766,105.3,105.3,9,0,0,50,0,29769,29819,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5749609,ERR5749609,B.1.617.2,21J (Delta),PASS,2323723,2323723,4641922,28881.5,99.9799,29770,392.1,392.1,35,0,0,282,0,29604,29886,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,Delta (B.1.617.2-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12661075,SRR12661075,B.1.452,20C,PASS,3399069,3399069,6783688,28944.7,100,29844,181.1,181.1,8,0,0,58,0,29845,29903,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5743043,ERR5743043,B.1.617.2,21J (Delta),PASS,1890053,1890053,3772972,23492.7,99.7659,29659,392.6,392.6,34,0,0,254,0,29567,29821,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,Delta (B.1.617.2-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -ERR5691945,ERR5691945,B.1.351,"20H (Beta, V2)",PASS,1735046,1735046,3464980,21560.2,99.9799,29546,392.5,392.5,26,0,0,419,0,29462,29881,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.194252,good,Beta (B.1.351-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR16298163,SRR16298163,None,,,162,162,314,1.03434,42.6746,0,120.2,121.4,0,98,98,29725,0,0,29725,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,,,,,,PANGO-v1.2.101,3.1.17,2021-11-25,v1.2.101,fail -ERR5405022,ERR5405022,B.1.1.7,"20I (Alpha, V1)",PASS,154545,154545,302416,1356.24,99.7258,28386,188.7,188.7,37,0,0,1399,0,28406,29805,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,16.567915,good,Alpha (B.1.1.7-like),PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR13358209,SRR13358209,B.1.1.440,20B,PASS,35450,35450,69674,324.214,99.8294,25955,148.7,148.7,6,0,1,3836,0,26029,29865,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,171.512977,bad,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR12162365,SRR12162365,B.1.1.136,20B,PASS,258545,258545,515974,2132.96,99.7091,29572,187.9,188.0,9,0,0,244,0,29572,29816,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,0.000000,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc -SRR11915959,SRR11915959,B.35,19A,PASS,553601,553601,1077732,5078.15,99.8595,28852,238.8,238.9,8,0,1,991,3,28869,29863,fastp 0.20.0,minimap2 : 2.23-r1111,samtools ampliconclip : samtools 1.13,iVar version 1.3.1,NC_045512,-,15.549808,good,,PLEARN-v1.2.101,3.1.17,2021-11-25,v1.2.101,passed_qc +sample_id,sample,pangolin_lineage,nextclade_clade,vadr_p/f,fastqc_raw_reads_1,fastqc_raw_reads_2,fastp_reads_passed,depth_after_trimming,1X_coverage_after_trimming,num_pos_100X,insert_size_before_trimming,insert_size_after_trimming,ivar_num_variants_identified,bedtools_num_failed_amplicons,samtools_num_failed_amplicons,num_N,num_degenerage,num_non-ambiguous,num_total,cleaner_version,aligner_version,trimmer_version,ivar_version,vadr_model,vadr_alerts,nextclade_qc.overallScore,nextclade_qc.overallStatus,pangolin_conflict,pangolin_ambiguity_score,pangolin_scorpio_call,pangolin_scorpio_support,pangolin_scorpio_conflict,pangolin_scorpio_notes,pangolin_version,pangolin_pangolin_version,pangolin_scorpio_version,pangolin_constellation_version,pangolin_is_designated,pangolin_qc_status,pangolin_qc_notes,pangolin_note,freyja_summarized,freyja_lineages,freyja_abundances,freyja_resid +SRR12901576,SRR12901576,B.1,20C,PASS,363267,363267,716516,3331.57,99.4482,29007,257.3,257.3,7,0,0,887,0,29013,29900,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,4.726598,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.04,Usher placements: B.1(1/1),"[('Other', 0.9893518338682183)]",['B.1.515' 'B.1.167' 'B.1.306' 'B.1.372' 'B.1.298'],[0.9776601 0.00420168 0.00329218 0.00292398 0.00127389],1.6107270850748099 +SRR16298158,SRR16298158,Unassigned,20A,FAIL,300310,300310,591874,799.286,43.31,5526,142.1,142.2,8,66,69,24336,1,5527,29864,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,7983.768549,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.82,,"[('Other', 0.9956744285982884)]",['B.1.177.33' 'AC.1'],[0.99377329 0.00190114],2.375946658763856 +SRR16298170,SRR16298170,Unassigned,19B,PASS,606680,606680,1197492,4602.22,90.4692,24992,162.0,162.0,3,1,2,4824,0,24993,29817,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,280.748642,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.18,,"[('A', 0.9920824410020388), ('Other', 0.00489688528405946)]",['A' 'B.23'],[0.99208244 0.00489689],1.7148428329830594 +SRR13004400,SRR13004400,B.1.264,20C,PASS,34961,34961,66438,487.73,99.7726,28363,384.6,385.1,7,0,0,1434,0,28401,29835,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,17.640000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.264(1/1),"[('Other', 0.9995194799995902)]",['B.1.264' 'B.1.320'],[0.998179 0.00134048],0.7655428044945682 +SRR12774785,SRR12774785,Unassigned,20C,PASS,29696,29696,58340,269.187,99.0402,25000,147.7,147.7,6,0,1,4849,1,25041,29891,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,284.860096,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.17,,"[('Other', 1.0000000000016165)]",['B.1.287' 'B.1.319' 'B.1.324'],[0.992063 0.00492611 0.00301089],0.4462579716279654 +SRR13603869,SRR13603869,B.1.427,21C (Epsilon),PASS,35473,35473,70064,338.536,98.7526,24349,154.7,154.7,14,0,3,5497,0,24369,29866,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,370.491207,bad,,,Epsilon (B.1.427-like),0.62,0.0,scorpio call: Alt alleles 8; Ref alleles 0; Amb alleles 5; Oth alleles 0,SCORPIO_v0.1.4,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.2,scorpio called lineage B.1.427,"[('Epsilon', 0.9999999999999818)]",['B.1.427'],[1.],2.493030850286815 +SRR13574337,SRR13574337,B.1.375,20C,PASS,1245538,1245538,2171070,1625.8,99.9967,29834,286.0,286.0,15,0,0,64,0,29833,29897,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9976111980027884)]",['B.1.375' 'B.1.306'],[0.996444 0.0011672],2.2997029529446453 +SRR16298157,SRR16298157,Unassigned,,,1691,1691,1732,0.0017724,0.0902919,0,26.5,26.5,0,98,98,18116,0,0,18116,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,,,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.7164179104476265), ('A', 0.2835820895521858)]","['B.1.1.161' 'B.10' 'B.3' 'B.18' 'B.29' 'B.41' 'B.33' 'B.61' 'B.28' 'A' + 'B.4' 'B.12' 'B.45' 'B.13' 'B.51' 'B.42' 'B.11' 'B.31' 'B.57' 'B.52' + 'B.46' 'B.47' 'B.6' 'B.5' 'B.19' 'B.23' 'B.26' 'B.55' 'B.27' 'B.1.14' + 'B.20' 'B.15' 'B.30' 'B.40' 'A.29' 'B.4.7' 'A.28' 'A.4' 'A.24' 'A.26' + 'A.25' 'A.3' 'A.27' 'A.12' 'A.11' 'A.2.3' 'A.2.2' 'A.7' 'A.2.4' 'A.6' + 'B.4.4' 'B.37' 'B.43' 'B.58' 'A.1' 'A.5' 'B.4.5' 'B.6.6' 'B.35' 'B.39' + 'B.60' 'A.2' 'B.4.6' 'B.3.1' 'B.34' 'B.32' 'B']","[0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 0.01492537 + 0.01492537]",2.3204233684889196e-13 +SRR16298164,SRR16298164,Unassigned,,,37159,37159,74240,0.0768485,4.21028,0,134.2,134.9,0,98,98,29849,0,0,29849,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,,,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9999999999999991)]",['B.1.127'],[1.],3.619421429444345e-15 +SRR13193342,SRR13193342,B.1,20C,PASS,78530,78530,152804,1109.75,99.9866,29354,572.6,572.9,10,0,0,528,0,29375,29903,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.713086,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1(1/1),"[('Other', 0.994915623992098)]",['B.1.320'],[0.99491562],2.1900421610502945 +SRR16298166,SRR16298166,Unassigned,,,6343,6343,4488,0.119018,9.70471,0,151.9,151.9,0,98,98,26645,0,0,26645,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,,,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9839357429710787), ('Alpha', 0.006693440428374595), ('Beta', 0.005354752342699676), ('Delta', 0.001338688085674919), ('Kappa', 0.001338688085674919), ('Eta', 0.001338688085674919)]","['AY.122.2' 'B.1.1.158' 'B.1.1.257' 'B.1.1.17' 'B.1.1.349' 'B.1.1.423' + 'B.1.1.232' 'B.1.1.8' 'B.1.1.480' 'B.1.1.119' 'B.1.1.464' 'B.1.1.220' + 'B.1.235' 'B.1.1.317' 'B.1.1.222' 'B.1.1.5' 'B.1.1.75' 'B.1.1.3' + 'B.1.1.154' 'B.1.1.404' 'B.1.1.297' 'B.1.530' 'B.1.1.458' 'B.1.1.63' + 'B.1.1.45' 'B.1.1.14' 'B.1.1.41' 'B.1.1.115' 'B.1.1.133' 'B.1.1.204' + 'B.1.1.421' 'B.1.1.270' 'B.1.1.82' 'B.1.1.253' 'B.1.1.15' 'B.1.1.255' + 'B.1.1.241' 'B.1.1.261' 'B.1.1.160' 'B.1.1.135' 'B.1.1.130' 'B.1.1.155' + 'B.1.1.384' 'B.1.1.426' 'B.1.1.304' 'B.1.232' 'B.1.402' 'B.1.413' + 'B.1.324' 'B.1.39' 'B.1.489' 'B.1.108' 'B.1.487' 'B.1.167' 'B.1.302' + 'B.1.268' 'B.1.453' 'B.1.572' 'B.1.485' 'B.1.551' 'B.1.320' 'B.1.510' + 'B.1.344' 'B.1.520' 'B.1.513' 'B.1.319' 'B.1.166' 'B.1.321' 'B.1.264' + 'B.1.330' 'B.1.333' 'B.1.431' 'B.1.511' 'B.1.407' 'B.1.408' 'B.1.231' + 'B.1.256' 'B.1.188' 'B.1.131' 'B.1.214' 'B.1.210' 'B.1.565' 'B.1.139' + 'B.1.478' 'B.1.273' 'B.1.277' 'B.1.274' 'B.1.13' 'B.1.37' 'B.1.479' + 'B.1.483' 'B.1.110.2' 'B.1.1.329' 'B.1.1.328' 'B.1.1.231' 'B.1.1.360' + 'B.1.497' 'B.1.493' 'B.1.359' 'B.1.1.408' 'B.1.1.374' 'B.1.1.327' + 'B.1.1.149' 'B.1.1.365' 'B.1.1.237' 'B.1.1.379' 'B.1.1.310' 'B.1.1.98' + 'B.1.1.144' 'B.1.1.181' 'B.1.1.51' 'B.1.1.305' 'B.1.1.48' 'B.1.1.210' + 'B.1.1.282' 'B.1.1.162' 'B.1.495' 'B.1.3' 'B.1.496' 'B.1.318' 'B.1.362' + 'B.1.289' 'B.1.334' 'B.1.451' 'B.1.335' 'B.1.168' 'B.1.337' 'B.1.355' + 'B.1.452' 'B.1.606' 'B.1.264.1' 'B.1.304' 'B.1.117' 'B.1.366' 'B.1.298' + 'B.1.515' 'B.1.428' 'B.1.287' 'B.1.369' 'B.1.1.285' 'B.1.1.113' + 'B.1.1.114' 'B.1.1.524' 'B.1.560' 'B.1.1.396' 'B.1.1.280' 'B.1.1.141' + 'B.1.1.217' 'D.3' 'B.1.1.193' 'B.1.1.67' 'B.1.1.116' 'B.1.1.70' + 'B.1.1.27' 'B.1.1.299' 'B.1.1.513' 'B.1.1.301' 'B.1.1.514' 'B.1.1.300' + 'B.1.1.307' 'B.1.1.107' 'B.1.1.309' 'B.1.1.46' 'B.1.1.132' 'B.1.1.213' + 'B.1.1.487' 'B.1.1.72' 'B.1.1.262' 'B.1.1.381' 'B.1.1.461' 'B.1.1.437' + 'B.1.1.385' 'B.1.1.263' 'B.1.1.359' 'B.1.1.345' 'B.1.1.177' 'B.1.1.111' + 'B.1.1.244' 'B.1.1.395' 'B.1.1.362' 'B.1.1.109' 'B.1.1.325' 'B.1.1.58' + 'B.1.1.228' 'B.1.1.416' 'B.1.360' 'B.1.38' 'B.1.586' 'B.1.199' 'B.58' + 'B.1.543' 'B.1.137' 'B.1.194' 'B.1.187' 'B.1.377' 'B.1.70' 'B.1.179' + 'B.1.91' 'B.1.378' 'B.1.81' 'B.1.545' 'B.1.134' 'B.1.195' 'B.1.78' + 'B.1.143' 'B.1.145' 'B.1.142' 'B.1.383' 'B.1.395' 'B.43' 'B.4.4' 'B.4.7' + 'B.1.220' 'B.1.180' 'B.1.182' 'B.1.126' 'B.1.379' 'B.1.222' 'B.1.106' + 'B.1.206' 'B.1.69' 'B.1.93' 'B.1.198' 'B.1.23' 'B.1.384' 'B.1.35' + 'B.1.205' 'B.1.208' 'B.1.146' 'B.1.6' 'B.1.213' 'B.1.147' 'B.1.201' + 'B.1.8' 'B.1.564' 'B.47' 'B.12' 'B.45' 'B.13' 'B.51' 'B.42' 'B.10' 'B.11' + 'B.57' 'B.52' 'B.6' 'B.1.215' 'B.5' 'B.19' 'B.23' 'B.26' 'B.55' 'B.27' + 'B.1.14' 'B.20' 'B.15' 'B.4' 'B.28' 'B.61' 'B.33' 'B.1.76' 'B.1.67' + 'B.4.8' 'B.4.5' 'B.6.6' 'B.35' 'B.39' 'B.60' 'B.1' 'B.4.6' 'B.3.1' 'B.34' + 'B.32' 'B.37' 'B.40' 'B.30' 'B.3' 'B.18' 'B.29' 'B.1.157' 'B.1.223' + 'B.1.609' 'B.1.1.59' 'B.1.1.169' 'B.1.1.438' 'B.1.1.440' 'B.1.1.378' + 'B.1.1.25' 'B.1.1.485' 'B.1.1.26' 'B.1.1.148' 'B.1.1.118' 'B.1.1.134' + 'B.1.420' 'B.1.173' 'B.1.1.137' 'B.1.1.200' 'B.1.1.164' 'B.1.1.122' + 'B.1.1.43' 'B.1.1.33' 'B.1.1.372' 'B.1.1.83' 'B.1.1.463' 'B.1.1.402' + 'B.1.1.174' 'B.1.1.185' 'B.1.294' 'B.1.323' 'B.1.115' 'B.1.315' 'B.1.267' + 'B.1.1.341' 'B.1.1.121' 'B.1.1.320' 'B.1.1.500' 'B.1.1.203' 'B.1.1.376' + 'B.1.1.172' 'B.1.1.306' 'B.1.1.187' 'B.1.1.441' 'B.1.1.398' 'B.1.1.10' + 'B.1.1.57' 'B.1.1.129' 'B.1.1.180' 'B.1.1.274' 'B.1.1.166' 'B.1.229' + 'B.1.416' 'B.1.546' 'B.1.636' 'B.1.393' 'B.1.153' 'B.1.552' 'B.1.96' + 'B.1.382' 'B.1.110' 'B.1.1' 'B.1.250' 'B.1.251' 'B.1.248' 'B.1.104' + 'B.1.391' 'B.1.559' 'B.1.415' 'B.1.418' 'B.1.181' 'B.1.233' 'B.1.556' + 'B.1.1.254' 'B.1.381' 'B.1.1.34' 'B.1.1.192' 'B.1.1.205' 'B.1.1.189' + 'B.1.1.71' 'B.1.1.142' 'B.1.1.197' 'B.1.1.95' 'B.1.252' 'B.1.254' + 'B.1.240' 'B.1.401' 'B.1.399' 'B.1.558' 'B.1.238' 'B.1.400' 'B.1.397' + 'B.1.239' 'B.1.243' 'B.1.310' 'B.1.424' 'Q.2' 'B.1.9.1' 'B.1.243.2' + 'B.1.617.1' 'B.1.221' 'B.1.36.12' 'B.1.36.28' 'B.1.36.38' 'B.1.9.5' + 'B.1.9.4' 'B.1.9.2' 'B.1.385' 'B.1.1.93' 'B.1.351' 'B.1.425' 'B.1.445' + 'B.1.362.2' 'B.1.570' 'B.1.569' 'B.1.338' 'B.1.305' 'B.1.428.3' + 'B.1.177.18' 'B.1.177.23' 'B.1.177.74' 'B.1.177.2' 'B.1.177.43' 'AA.1' + 'B.1.400.1' 'B.1.561' 'B.1.258.14' 'B.1.36.26' 'B.1.36.17' 'B.1.1.236' + 'C.36' 'C.23' 'B.1.1.251' 'B.1.1.338' 'B.1.1.348' 'B.1.177.77' + 'B.1.177.21' 'B.1.177.53' 'B.1.177.85' 'B.1.177.50' 'B.1.177.3' + 'B.1.564.1' 'B.1.1.279' 'B.1.443' 'B.1.421' 'B.1.177.24' 'B.1.177.51' + 'B.1.177.71' 'B.1.177.45' 'B.1.177.32' 'B.1.177.20' 'B.1.177.19' + 'B.1.177.69' 'B.1.177.33' 'B.1.409' 'B.1.1.286' 'B.1.258' 'B.1.469' + 'B.1.36.10' 'B.1.36.1' 'B.1.36.16' 'B.1.36.8' 'B.1.36.35' 'B.1.36.24' + 'B.1.36.7' 'B.1.177.52' 'B.1.177.25' 'B.1.1.316' 'C.35' 'B.1.1.44' 'D.4' + 'B.1.1.161' 'B.1.1.207' 'B.1.1.227' 'B.1.1.190' 'B.1.1.269' 'B.1.1.153' + 'C.28' 'C.5' 'C.32' 'C.26' 'C.4' 'C.1' 'C.14' 'C.3' 'C.27' 'C.12' 'C.13' + 'B.1.177.73' 'W.2' 'B.1.177.56' 'B.1.36.39' 'AA.3' 'B.1.1.7' 'R.1' 'AA.2' + 'AA.5' 'AA.6' 'AA.4' 'AA.8' 'B.1.221.3' 'B.1.351.3' 'B.1.177.55' + 'B.1.351.2' 'U.1' 'B.1.177.62' 'B.1.258.17' 'B.1.221.1' 'B.1.361' + 'B.1.587' 'B.1.575' 'B.1.177.86' 'B.1.177.63' 'B.1.351.5' 'B.1.637' + 'B.1.160.32' 'B.1.177.31' 'B.1.160.12' 'B.1.1.445' 'B.1.160.23' 'Q.4' + 'B.1.160.26' 'B.1.160.11' 'B.1.160.13' 'Q.1' 'Q.3' 'B.1.160.15' + 'B.1.160.33' 'B.1.160.10' 'B.1.160.31' 'B.1.160.20' 'B.1.160.22' + 'B.1.160.7' 'B.1.160.30' 'AA.7' 'U.3' 'B.1.177.67' 'V.2' 'B.1.258.11' + 'B.1.36.22' 'B.1.562' 'B.1.423' 'B.1.588' 'B.1.1.303' 'C.18' 'C.20' + 'B.1.1.277' 'AM.3' 'B.1.177.81' 'Y.1' 'B.1.177.59' 'B.1.177.65' + 'B.1.177.60' 'B.1.177.8' 'B.1.177.48' 'B.1.177.7' 'B.1.177.58' + 'B.1.177.5' 'B.1.36.21' 'B.1.258.12' 'V.1' 'B.1.258.6' 'B.1.177.11' + 'B.1.258.5' 'B.1.258.22' 'B.1.258.10' 'B.1.36.2' 'B.1.640' 'B.1.438.4' + 'C.38' 'Z.1' 'B.1.177.54' 'W.1' 'W.4' 'B.1.177.4' 'B.1.177.12' + 'B.1.177.40' 'B.1.177.35' 'B.1.177.44' 'B.1.177.15' 'B.1.258.7' + 'B.1.466.2' 'B.1.9' 'B.1.450' 'B.1.1.38' 'B.1.1.371' 'B.1.1.298' + 'B.1.1.1' 'B.1.1.186' 'B.1.1.55' 'B.1.1.339' 'B.1.1.165' 'B.1.1.392' + 'B.1.1.208' 'B.1.1.138' 'B.1.177' 'B.1.1.194' 'B.1.1.389' 'B.1.1.326' + 'B.1.1.368' 'B.1.1.355' 'B.1.1.518' 'B.1.1.521' 'AS.1' 'B.1.1.289' 'B.59' + 'B.1.1.123' 'B.1.1.406' 'B.1.1.97' 'B.1.1.209' 'B.1.1.403' 'L.2' + 'B.1.1.288' 'B.1.1.13' 'B.1.1.432' 'B.1.1.120' 'B.1.1.354' 'B.1.533' + 'B.1.1.147' 'B.1.1.512' 'B.1.1.268' 'B.1.1.16' 'B.1.1.240' 'B.1.1.311' + 'B.1.1.308' 'B.1.1.86' 'B.1.1.420' 'B.1.1.256' 'B.1.525' 'B.1.554' + 'B.1.605' 'B.1.349' 'B.1.328' 'B.1.340' 'B.1.356' 'B.1.12' 'B.1.582' + 'B.1.372' 'B.1.607' 'B.1.342' 'B.1.293' 'B.1.332' 'B.1.405' 'B.1.306' + 'B.1.22' 'B.1.116' 'B.1.590' 'B.1.370' 'B.1.336' 'B.1.265' 'B.1.595' + 'B.1.301' 'B.1.40' 'B.1.597' 'B.1.492' 'B.1.465' 'B.1.241' 'B.1.610' + 'B.1.602' 'B.1.234' 'B.1.396' 'B.1.416.1' 'B.1.1.291' 'B.1.113' 'B.1.97' + 'B.1.524' 'B.1.280' 'B.1.474' 'B.1.276' 'B.1.110.1' 'B.1.462' 'B.1.467' + 'B.1.471' 'B.1.523' 'B.1.470' 'B.1.1.50' 'B.1.1.47' 'B.1.1.284' 'AH.2' + 'B.1.1.353' 'B.1.1.182' 'D.2' 'B.1.1.450' 'B.1.1.344' 'B.1.1.198' + 'B.1.1.302' 'B.1.1.170' 'B.1.1.397' 'AH.1' 'B.1.1.214' 'B.1.1.29' + 'B.1.1.216' 'AK.1' 'B.1.1.171' 'B.1.1.418' 'AG.1' 'B.1.177.72' + 'B.1.177.16' 'B.1.177.17' 'B.1.1.351' 'B.1.1.243' 'B.1.1.358' 'B.1.1.482' + 'B.1.585' 'B.1.433' 'B.1.435' 'B.1.521' 'B.1.595.4' 'B.1.595.3' + 'B.1.595.2' 'B.1.591' 'B.1.362.1' 'B.1.541' 'B.1.444' 'B.1.165' 'B.1.574' + 'B.1.428.2' 'B.1.428.1' 'B.1.1.322' 'AE.7' 'AE.2' 'B.1.1.425' 'B.1.88.1' + 'B.1.398' 'B.1.627' 'B.1.44' 'B.1.448' 'B.1.594' 'B.1.567' 'B.1.589' + 'B.1.577' 'B.1.603' 'B.1.120' 'B.1.576' 'B.1.571' 'B.1.494' 'B.1.1.486' + 'B.1.1.363' 'AE.4' 'B.1.548' 'AE.6' 'AE.1' 'B.1.1.428' 'B.1.1.139' + 'B.1.1.226' 'B.1.596.1' 'B.1.581' 'B.1.184' 'B.1.580' 'B.1.36' + 'B.1.36.19' 'B.1.456' 'B.1.468' 'B.1.466' 'B.1.170' 'B.1.164' 'B.1.162' + 'B.1.245' 'B.1.111' 'B.1.473' 'B.1.124' 'B.1.436' 'B.1.442' 'B.1.161' + 'B.1.439' 'B.1.163' 'B.1.112' 'B.1.578' 'B']","[0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 0.00133869 + 0.00133869 0.00133869 0.00133869]",5.434414022852138e-13 +SRR16298172,SRR16298172,Unassigned,19A,PASS,2604,2604,5108,21.5379,99.7826,194,198.1,200.7,0,2,86,29642,0,196,29838,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,11810.054376,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9999999999994847)]",['B'],[1.],1.6516651148860908 +SRR13689874,SRR13689874,B.1.1.512,20B,PASS,301254,301254,600498,2747.44,99.9565,29498,226.8,226.8,27,0,0,401,0,29501,29902,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,21.146876,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.1.512(1/1),"[('Other', 0.9988039999996169)]",['B.1.1.512'],[0.998804],5.769895398581209 +SRR16298159,SRR16298159,Unassigned,,,27131,27131,49602,0.308631,18.5232,0,149.3,149.2,0,98,98,29550,0,0,29550,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,,,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9976851851832905), ('Zeta', 0.0023148148148104115)]","['AZ.2.1' 'B.1.1.500' 'B.1.1.174' 'B.1.1.185' 'B.1.1.129' 'B.1.1.57' + 'B.1.1.10' 'B.1.1.398' 'B.1.1.441' 'B.1.1.447' 'B.1.1.175' 'B.1.1.376' + 'B.1.1.203' 'B.1.1.275' 'AZ.4' 'B.1.267' 'B.1.315' 'B.1.115' 'B.1.323' + 'B.1.294' 'B.1.564' 'B.1.413' 'B.1.264' 'B.1.321' 'B.1.166' 'B.1.319' + 'B.1.1.402' 'B.1.1.169' 'B.1.1.438' 'B.1.1.440' 'B.1.1.192' 'B.1.1.34' + 'B.1.1.254' 'B.1.1.166' 'B.1.1.274' 'B.1.1.83' 'B.1.1.372' 'B.1.1.33' + 'B.1.1.43' 'B.1.1.122' 'B.1.1.164' 'B.1.1.200' 'B.1.1.137' 'B.1.173' + 'B.1.1.134' 'B.1.1.118' 'B.1.1.148' 'B.1.1.12' 'B.1.1.168' 'B.1.1.26' + 'B.1.1.485' 'B.1.1.25' 'B.1.1.378' 'B.1.513' 'B.1.520' 'B.1.344' + 'B.1.551' 'B.1.232' 'B.1.530' 'B.1.1.404' 'B.1.1.75' 'B.1.1.5' + 'B.1.1.222' 'B.1.1.317' 'B.1.1.220' 'B.1.1.158' 'B.1.1.464' 'B.1.1.8' + 'B.1.1.423' 'B.1.1.17' 'B.1.1.257' 'B.1.1.323' 'B.1.1.458' 'B.1.1.63' + 'B.1.1.45' 'B.1.1.14' 'B.1.1.384' 'B.1.1.130' 'B.1.1.135' 'B.1.1.160' + 'B.1.235' 'B.1.407' 'B.1.510' 'B.1.408' 'B.1.485' 'B.1.324' 'B.1.572' + 'B.1.268' 'B.1.487' 'B.1.108' 'B.1.489' 'B.1.39' 'B.1.329' 'B.1.330' + 'B.1.333' 'B.1.431' 'B.1.511' 'B.1.483' 'B.1.479' 'B.1.13' 'B.1.274' + 'B.1.277' 'B.1.273' 'B.1.478' 'B.1.139' 'B.1.565' 'B.1.210' 'B.1.1.205' + 'B.1.1.189' 'B.1.1.71' 'B.1' 'B.39' 'B.35' 'B.6.6' 'B.1.67' 'B.1.76' + 'B.1.215' 'B.1.8' 'B.1.81' 'B.1.201' 'B.1.395' 'B.1.383' 'B.1.142' + 'B.1.143' 'B.1.78' 'B.1.195' 'B.1.134' 'B.1.545' 'B.1.378' 'B.1.199' + 'B.1.91' 'B.1.179' 'B.1.70' 'B.1.377' 'B.60' 'B.3.1' 'B.1.543' 'B.34' + 'B.15' 'B.20' 'B.1.14' 'B.27' 'B.26' 'B.23' 'B.6' 'B.47' 'B.57' 'B.10' + 'B.42' 'B.12' 'B.28' 'B.61' 'B.33' 'B.41' 'B.29' 'B.3' 'B.30' 'B.31' + 'B.40' 'B.37' 'B.32' 'B.1.194' 'B.58' 'B.1.1.142' 'B.1.248' 'B.1.250' + 'B.1.1' 'B.1.382' 'B.1.96' 'B.1.153' 'B.1.393' 'B.1.416' 'B.1.233' + 'B.1.229' 'B.1.556' 'B.1.243' 'B.1.239' 'B.1.397' 'B.1.400' 'B.1.238' + 'B.1.558' 'B.1.399' 'B.1.401' 'B.1.240' 'B.1.249' 'B.1.254' 'B.1.252' + 'B.1.1.92' 'B.1.251' 'B.1.104' 'B.43' 'B.1.391' 'B.1.103' 'B.1.178' + 'B.1.147' 'B.1.213' 'B.1.6' 'B.1.151' 'B.1.208' 'B.1.218' 'B.1.205' + 'B.1.35' 'B.1.23' 'B.1.198' 'B.1.106' 'B.1.379' 'B.1.182' 'B.1.180' + 'B.1.223' 'B.1.225' 'B.1.420' 'B.1.181' 'B.1.418' 'B.1.415' 'B.1.559' + 'B.1.1.261' 'B.1.1.241' 'B.1.1.253' 'B.1.44' 'B.1.439' 'B.1.161' + 'B.1.124' 'B.1.245' 'B.1.162' 'B.1.164' 'B.1.170' 'B.1.466' 'B.1.456' + 'B.1.627' 'B.1.398' 'B.1.1.4' 'B.1.1.216' 'B.1.1.29' 'P.7' 'AH.1' 'AH.2' + 'B.1.1.467' 'B.1.1.294' 'B.1.1.344' 'B.1.1.482' 'B.1.1.322' 'B.1.428.1' + 'B.1.112' 'B.1.596.1' 'B.1.165' 'B.1.448' 'N.4' 'N.3' 'N.1' 'B.1.1.61' + 'AN.1' 'B.1.1.97' 'B.1.1.159' 'B.1.1.308' 'B.1.1.311' 'B.1.1.16' + 'B.1.1.89' 'B.1.533' 'B.1.1.136' 'B.1.1.13' 'L.2' 'B.1.1.214' 'B.1.1.226' + 'B.1.1.363' 'B.1.1.373' 'B.1.494' 'B.1.120' 'B.1.579' 'B.1.314' + 'B.1.428.2' 'B.1.521' 'B.1.1.1' 'B.1.428.3' 'B.1.441' 'B.1.385' 'B.1.9.1' + 'B.1.9.2' 'B.1.9.4' 'B.1.9.5' 'B.1.221' 'B.1.1.348' 'C.23' 'C.36' + 'B.1.1.375' 'M.2' 'B.1.1.236' 'AF.1' 'B.1.1.290' 'B.1.400.1' 'B.1.1.277' + 'B.1.1.303' 'B.1.562' 'B.1.221.1' 'B.1.1.318' 'AZ.3' 'AZ.2' 'B.1.570' + 'B.1.564.1' 'B.1.433' 'L.4' 'B.1.9' 'B.1.443' 'B.1.469' 'B.1.214.3' + 'B.1.409' 'P.2' 'C.35' 'C.13' 'C.12' 'C.27' 'C.25' 'C.3' 'C.14' 'C.1' + 'C.4' 'C.32' 'C.2' 'B.1.1.269' 'B.1.1.190' 'B.1.1.207' 'B.1.1.161' 'D.4' + 'B.1.1.44' 'B.59' 'B.1.1.186' 'B.1.1.82' 'B.1.1.381' 'B.1.1.213' + 'B.1.1.113' 'B.1.1.285' 'B.1.1.162' 'B.1.1.210' 'B.1.1.48' 'B.1.1.305' + 'B.1.1.49' 'B.1.1.51' 'B.1.1.98' 'B.1.1.379' 'B.1.1.360' 'B.1.1.237' + 'B.1.1.365' 'B.1.1.408' 'B.1.359' 'B.1.493' 'B.1.3' 'B.1.496' 'B.1.318' + 'B.1.369' 'B.1.287' 'B.1.428' 'B.1.1.262' 'B.1.1.263' 'B.1.298' + 'B.1.1.359' 'B.1.1.204' 'B.1.1.133' 'B.1.1.115' 'B.1.1.41' 'B.1.1.231' + 'B.1.1.310' 'B.1.1.107' 'B.1.1.307' 'B.1.1.116' 'B.1.1.67' 'D.3' + 'B.1.1.217' 'B.1.1.141' 'B.1.1.506' 'B.1.1.46' 'B.1.1.132' 'B.1.1.416' + 'B.1.1.266' 'B.1.1.58' 'B.1.1.325' 'B.1.1.362' 'B.1.1.244' 'B.1.1.177' + 'B.1.515' 'B.1.366' 'B.1.1.55' 'B.1.492' 'B.1.470' 'B.1.523' 'B.1.471' + 'B.1.462' 'B.1.97' 'B.1.1.291' 'B.1.416.1' 'B.1.610' 'B.1.241' 'B.1.405' + 'B.1.1.289' 'B.1.1.459' 'B.1.1.77' 'B.1.1.521' 'B.1.1.368' 'B.1.1.326' + 'B.1.1.125' 'B.1.1.194' 'B.1.1.138' 'B.1.1.38' 'B.1.1.208' 'B.1.1.128' + 'B.1.1.392' 'B.1.465' 'B.1.340' 'B.1.304' 'B.1.356' 'B.1.264.1' 'B.1.606' + 'B.1.452' 'B.1.355' 'B.1.168' 'B.1.451' 'B.1.334' 'B.1.310' 'B.1.424' + 'B.1.450' 'B.1.301' 'B.1.265' 'B.1.336' 'B.1.370' 'B.1.590' 'B.1.116' + 'B.1.22' 'B.1.332' 'B.1.293' 'B.1.342' 'B.1.607' 'B.1.372' 'B.1.12' 'B']","[0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 + 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481 0.00231481]",0.6309297535727268 +SRR13433883,SRR13433883,B.1.258.23,20A,PASS,106223,106223,211024,959.652,99.9465,28511,280.2,280.3,25,0,3,1360,0,28537,29897,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,91.975394,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.258.23(1/1),"[('Other', 0.999999999999979)]",['B.1.258.23'],[1.],1.2862940120429618 +SRR13373851,SRR13373851,B.1.492,20C,PASS,184210,184210,358288,1656.81,99.8428,29734,149.8,149.8,8,0,0,124,0,29743,29867,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.492(1/1),"[('Other', 0.9991610000000027)]",['B.1.492'],[0.999161],1.1693248378326389 +SRR13062553,SRR13062553,B.1.265,20C,PASS,20718,20718,40946,296.319,99.8161,28023,393.2,393.9,6,0,0,1767,0,28081,29848,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,29.521111,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.07,Usher placements: B.1.265(1/1),"[('Other', 0.9999999999999803)]",['B.1.265'],[1.],0.6627829973458741 +SRR13195052,SRR13195052,B.1.1.139,20B,PASS,416419,416419,830676,3600.39,99.9799,29738,195.3,195.3,10,0,0,151,0,29751,29902,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.139(1/1),"[('Other', 0.9961511470031156)]",['B.1.1.139'],[0.99615115],1.1352604806763824 +SRR12212912,SRR12212912,B.1.112,20A,PASS,274115,274115,542002,2530.88,99.9565,29461,269.0,269.1,10,0,0,439,0,29464,29903,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.265034,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.112(1/1),"[('Other', 0.9969927770072395)]",['B.1.112'],[0.99699278],0.6099779011372437 +SRR13500958,SRR13500958,P.2,20B,PASS,73899,73899,146510,1012.95,99.7659,28045,382.1,382.3,22,0,0,1771,0,28062,29833,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,29.682318,good,0.0,,Zeta (P.2-like),0.86,0.14,scorpio call: Alt alleles 6; Ref alleles 1; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.07,Usher placements: P.2(1/1),"[('Zeta', 0.9999999999981593)]",['P.2'],[1.],2.287678169861591 +SRR13526755,SRR13526755,B.1.1.418,20B,PASS,1068040,1068040,2109874,9131.94,99.8997,29794,177.2,177.2,18,0,0,79,0,29794,29873,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.418(1/1),"[('Other', 0.99878133169988)]",['B.1.1.418'],[0.99878133],0.5744564220505675 +SRR13001544,SRR13001544,B.1.199,20A,PASS,152965,152965,304434,2173.23,99.8763,29782,381.4,381.5,6,0,0,84,0,29782,29866,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9884358200008779)]",['B.1.199' 'B.1.378' 'B.1.545' 'B.1.393'],[0.98451874 0.00179051 0.00111545 0.00101112],0.8307557960532008 +SRR16298173,SRR16298173,Unassigned,19A,PASS,138431,138431,272324,1042.65,93.4053,25153,164.0,164.1,0,0,0,4682,1,25156,29839,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,264.400878,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.17,,"[('Other', 0.9973902749976506)]",['B' 'B.10' 'B.57'],[0.99344461 0.00289855 0.00104712],0.5090118196083717 +SRR16298163,SRR16298163,Unassigned,,,162,162,314,1.03434,42.6746,0,120.2,121.4,0,98,98,29725,0,0,29725,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,,,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9999999999946394)]","['B.1.36.38' 'B.1.437' 'B.1.39' 'B.1.489' 'B.1.302' 'B.1.453' 'B.1.572' + 'B.1.324' 'B.1.320' 'B.1.510' 'B.1.344' 'B.1.520' 'B.1.513' 'B.1.319' + 'B.1.321' 'B.1.413' 'B.1.294' 'B.1.333' 'B.1.428' 'B.1.570' 'B.1.298' + 'B.1.428.3' 'B.1.428.1' 'B.1.491' 'B.1.44' 'B.1.314' 'B.1.576' 'B.1.533' + 'B.1.40' 'B.1.340' 'B.1.582' 'B.1.349' 'B.1.22' 'B.1.586' 'B.1.334' + 'B.1.304' 'B.1.267']","[0.05869503 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 + 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 + 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 + 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 + 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 + 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 0.02614736 + 0.02614736]",2.7079696506456985 +ERR5181310,ERR5181310,B.1.525,21D (Eta),PASS,912571,912571,1819962,11314.8,99.6288,29711,392.6,392.6,35,0,0,94,0,29706,29800,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,DELETION_OF_FEATURE(deletina),0.000000,good,0.0,,Eta (B.1.525-like),1.0,0.0,scorpio call: Alt alleles 16; Ref alleles 0; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.525(8/8),"[('Eta', 0.9995329999382483)]",['B.1.525'],[0.999533],5.007163726237424 +SRR13690003,SRR13690003,B.1,20G,PASS,753605,753605,1503954,6721.78,99.9666,29618,197.7,197.7,18,0,0,275,7,29611,29893,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,53.340278,mediocre,0.5,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1(1/2) B.1.2(1/2),"[('Other', 0.8758938800128273), ('Epsilon', 0.11379590388162412)]",['B.1.2' 'B.1.550' 'B.1.427'],[0.65292012 0.22297376 0.1137959 ],5.81013479633677 +SRR13687078,SRR13687078,B.1.1.362,20B,PASS,33826,33826,66586,314.888,99.6288,27194,152.0,152.0,9,0,0,2584,0,27302,29886,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,71.559067,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.1,Usher placements: B.1.1.362(2/2),"[('Other', 0.999999999999996)]",['B.1.1.362'],[1.],1.2524475392457326 +SRR12192434,SRR12192434,B.1.336,20C,PASS,22164,22164,42914,182.928,99.9599,28314,181.9,182.1,4,0,0,1507,1,28383,29891,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,20.984211,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.336(1/1),"[('Other', 0.9999999999999916)]",['B.1.336'],[1.],1.3849496433939936 +SRR16298175,SRR16298175,Unassigned,19A,PASS,142646,142646,282724,182.947,62.2011,6180,156.0,156.1,2,50,66,23681,0,6183,29864,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,7498.918532,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.79,,"[('Other', 0.9926319948168911)]","['B.1.390' 'B.1.350' 'B.1.489' 'B.1.110' 'B.1.323' 'B.1.413' 'B.1.165' + 'B.1.513' 'B.1.510' 'B.1.572' 'B.1.268' 'B.1.453' 'B.1.314' 'B.1.287' + 'B.1.428' 'B.1.1.261' 'B.1.96' 'B.1.379' 'B.1.182' 'B.1.180' 'B.1.223' + 'B.1.225' 'B.1.609' 'B.1.134' 'B.1' 'B.1.8' 'B.1.143' 'B.1.67' 'B.1.378' + 'B.1.145' 'B.1.210' 'B.1.6' 'B.1.428.1' 'B.1.402' 'B.1.110.1' 'B.1.1.37' + 'B.1.1.283' 'B.55' 'B.1.310' 'B.1.39' 'B.1.570' 'B.1.1.175' 'B.1.1.384' + 'B.1.1.351' 'B.1.415']","[0.0364964 0.03371192 0.03371192 0.03371192 0.03371192 0.03371192 + 0.03371192 0.03371192 0.03371192 0.03371192 0.03371192 0.03371192 + 0.03371192 0.03371192 0.03371192 0.02584372 0.02577063 0.02577063 + 0.02577063 0.02577063 0.02577063 0.02577063 0.02577063 0.02577063 + 0.02577063 0.02577063 0.02577063 0.02577063 0.02577063 0.02577063 + 0.02577063 0.02577063 0.01582298 0.00769231 0.00471698 0.00292398 + 0.0027027 0.00244499 0.00204918 0.00159744 0.0015083 0.001321 + 0.00109769 0.00108108 0.00103627]",2.0670637524379902 +SRR12162365,SRR12162365,B.1.1,20B,PASS,258545,258545,515974,2132.96,99.7091,29572,187.9,188.0,9,0,0,244,0,29572,29816,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1(1/1),"[('Other', 0.9841225800066347)]","['B.1.1.136' 'B.1.1.402' 'B.1.1.194' 'B.1.1.180' 'B.1.533' 'B.1.1.92' + 'B.1.1.128' 'B.1.1.463']","[0.87085458 0.10473846 0.00229095 0.00156006 0.00131272 0.00122549 + 0.00110619 0.00103413]",1.5312720203260308 +SRR16298167,SRR16298167,Unassigned,,,1330,1330,1058,0.0461158,3.34415,0,286.0,286.0,0,98,98,14209,0,0,14209,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,,,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,,,, +SRR16298161,SRR16298161,Unassigned,20C,FAIL,188463,188463,368960,869.357,67.0769,12782,127.9,128.0,13,24,39,16274,0,12795,29069,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,3559.283964,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.57,,"[('Other', 0.998906637000648)]",['B.1.2'],[0.99890664],2.1828708713346954 +SRR13297853,SRR13297853,B.1.323,20C,PASS,372300,372300,707438,4693.56,99.9131,29782,538.9,538.9,7,0,0,67,0,29812,29879,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9938999649897017)]",['B.1.323'],[0.99389996],0.595263258546421 +SRR13690340,SRR13690340,B.1.232,20A,PASS,333889,333889,666534,2900.88,99.9632,29573,193.5,193.6,18,0,0,330,1,29572,29903,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,7.262346,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.232(1/1),"[('Other', 0.9930225150267495)]",['B.1.232' 'B.1.2' 'B.1.383' 'B.1.382'],[0.697944 0.27293396 0.02071701 0.00142755],2.5402090384017297 +SRR14241199,SRR14241199,B.1.526,21F (Iota),PASS,222498,222498,405236,3010.42,99.7994,28437,384.8,384.9,24,0,0,1394,0,28439,29833,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,27.528615,good,0.0,,Iota (B.1.526-like),0.83,0.17,scorpio call: Alt alleles 19; Ref alleles 4; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: B.1.526(4/4),"[('Iota', 0.9994372359707291)]",['B.1.526'],[0.99943724],3.61753202502429 +SRR13422802,SRR13422802,B.1.427,21C (Epsilon),PASS,146635,146635,287962,2100.45,99.5419,29344,384.7,384.9,19,0,0,492,0,29344,29836,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.505679,good,0.0,,Epsilon (B.1.427-like),0.92,0.0,scorpio call: Alt alleles 12; Ref alleles 0; Amb alleles 1; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.427(1/1),"[('Epsilon', 0.9975658090057523)]",['B.1.427'],[0.99756581],2.782382039612967 +SRR12833718,SRR12833718,B.1.1.174,20B,PASS,651160,651160,1298520,5611.08,97.5655,27396,185.7,185.7,14,0,1,2161,8,27396,29565,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,113.070333,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.09,Usher placements: B.1.1.174(1/1),"[('Other', 0.9988246830860479)]",['B.1.1.174'],[0.99882468],2.5103279126097537 +SRR12751757,SRR12751757,Unassigned,20F,PASS,497470,497470,984480,4591.19,97.9734,24303,214.5,214.5,14,0,2,5544,1,24309,29854,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,378.222716,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.19,,"[('Other', 0.9991589999999612)]",['D.2'],[0.999159],2.0025642815191427 +ERR5556343,ERR5556343,P.1,"20J (Gamma, V3)",PASS,216817,216817,433046,2675.35,99.6756,28030,386.4,386.4,32,0,0,1766,0,28035,29801,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,29.480878,good,0.3333333333333333,,Gamma (P.1-like),0.88,0.0,scorpio call: Alt alleles 14; Ref alleles 0; Amb alleles 0; Oth alleles 2,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.07,Usher placements: P.1(4/6) P.1.12(1/6) P.1.3(1/6),"[('Gamma', 0.9997150999997542)]",['P.1.12'],[0.9997151],1.5244422504051451 +SRR16298174,SRR16298174,Unassigned,,,148231,148231,292562,0.424941,22.3422,0,148.9,148.8,0,98,98,29441,0,0,29441,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,,,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9111111110645748), ('A', 0.0888888888885006)]","['B' 'B.60' 'B.29' 'B.18' 'B.3' 'B.30' 'B.40' 'B.37' 'B.32' 'B.34' 'B.3.1' + 'B.39' 'B.33' 'B.35' 'A.5' 'B.58' 'B.43' 'A.24' 'A.26' 'A.25' 'A.11' + 'A.19' 'B.41' 'A.21' 'B.61' 'B.47' 'B.28' 'B.15' 'B.20' 'B.1.14' 'B.26' + 'B.1.1.161' 'B.23' 'B.19' 'B.6' 'B.27' 'B.52' 'B.13' 'B.12' 'B.45' 'A' + 'B.51' 'B.10' 'B.42' 'B.57' 'B.1.1.175' 'B.1.1.376' 'B.1.1.203' + 'B.1.1.500' 'B.1.1.447' 'B.1.1.121' 'B.1.1.306' 'B.1.1.187' 'B.1.1.441' + 'B.1.1.172' 'B.1.1.57' 'B.1.1.398' 'B.1.1.367' 'B.1.1.43' 'B.1.1.122' + 'B.1.1.164' 'B.1.1.137' 'B.1.1.134' 'B.1.1.59' 'B.1.1.148' 'B.1.267' + 'B.1.1.485' 'B.1.1.25' 'B.1.1.378' 'B.1.1.440' 'B.1.1.463' 'B.1.1.129' + 'B.1.1.364' 'B.1.38' 'B.1.115' 'B.1.323' 'B.1.274' 'B.1.13' 'B.1.37' + 'B.1.479' 'B.1.483' 'B.1.431' 'B.1.333' 'B.1.330' 'B.1.329' 'B.1.39' + 'B.1.489' 'B.1.108' 'B.1.487' 'B.1.167' 'B.1.302' 'B.1.453' 'B.1.324' + 'B.1.320' 'B.1.510' 'B.1.520' 'B.1.513' 'B.1.319' 'B.1.166' 'B.1.1.180' + 'B.1.350' 'B.1.321' 'B.1.360' 'B.1.413' 'B.1.277' 'B.1.1.33' 'B.1.399' + 'B.1.1.274' 'B.1.93' 'B.1.23' 'B.1.384' 'B.1.35' 'B.1.205' 'B.1.151' + 'B.1.6' 'B.1.213' 'B.1.178' 'B.1.220' 'B.1.543' 'B.1.137' 'B.1.194' + 'B.1.70' 'B.1.199' 'B.1.545' 'B.1.78' 'B.1.145' 'B.1.142' 'B.1.383' + 'B.1.395' 'B.1.201' 'B.1.81' 'B.1.8' 'B.1.215' 'B.1.76' 'B.1.67' 'B.1' + 'B.1.198' 'B.1.222' 'B.1.1.166' 'B.1.379' 'B.1.1.192' 'B.1.1.205' + 'B.1.1.189' 'B.1.1.71' 'B.1.1.142' 'B.1.1.95' 'B.1.401' 'B.1.558' + 'B.1.238' 'B.1.397' 'B.1.229' 'B.1.233' 'B.1.416' 'B.1.600' 'B.1.393' + 'B.1.153' 'B.1.96' 'B.1.231' 'B.1.1' 'B.1.415' 'B.1.181' 'B.1.420' + 'B.1.609' 'B.1.225' 'B.1.223' 'B.1.180' 'B.1.182' 'B.1.210' 'B.1.1.219' + 'B.1.408' 'B.1.1.239' 'B.1.610' 'B.1.241' 'B.1.405' 'B.1.554' 'B.1.1.368' + 'B.1.1.326' 'B.1.1.194' 'B.1.1.38' 'B.1.1.165' 'B.59' 'N.4' 'N.3' 'N.1' + 'N.2' 'N.6' 'B.1.1.61' 'B.1.1.256' 'B.1.403' 'B.1.416.1' 'B.1.97' + 'B.1.342' 'B.1.265' 'B.1.336' 'B.1.370' 'B.1.116' 'B.1.22' 'B.1.332' + 'B.1.293' 'B.1.372' 'B.1.524' 'B.1.12' 'B.1.356' 'B.1.340' 'B.1.40' + 'B.1.597' 'B.1.492' 'B.1.276' 'B.1.1.308' 'B.1.1.89' 'B.1.450' 'B.1.533' + 'D.5' 'B.1.1.182' 'B.1.1.243' 'B.1.1.482' 'B.1.574' 'B.1.165' 'B.1.521' + 'B.1.435' 'B.1.409' 'B.1.1.269' 'B.1.532' 'B.1.1.207' 'B.1.1.453' 'AV.1' + 'B.1.1.44' 'B.1.445' 'B.1.375' 'N.8' 'N.5' 'B.1.1.170' 'B.1.1.428' + 'B.1.1.354' 'B.1.1.432' 'B.1.1.13' 'B.1.1.209' 'B.1.1.50' 'B.1.1.226' + 'B.1.1.139' 'AE.1' 'B.1.1.171' 'AE.6' 'B.1.576' 'B.1.314' 'B.1.426' + 'B.1.448' 'B.1.596.1' 'B.1.578' 'B.1.301' 'B.1.424' 'B.1.1.236' 'B.1.560' + 'B.1.1.115' 'B.1.1.41' 'B.1.1.37' 'B.1.1.310' 'B.1.1.309' 'B.1.1.356' + 'B.1.1.107' 'B.1.1.307' 'B.1.1.300' 'B.1.1.514' 'B.1.1.301' 'B.1.1.70' + 'B.1.1.116' 'B.1.1.67' 'B.1.1.217' 'B.1.1.141' 'B.1.1.280' 'B.1.1.133' + 'B.1.1.421' 'B.1.1.249' 'B.1.1.8' 'B.1.551' 'B.1.402' 'B.1.235' 'B.1.236' + 'B.1.530' 'B.1.1.297' 'B.1.1.404' 'B.1.1.423' 'B.1.1.270' 'B.1.1.17' + 'B.1.1.63' 'B.1.1.14' 'B.1.1.258' 'B.1.1.261' 'B.1.1.253' 'B.1.1.82' + 'B.1.1.506' 'B.1.1.487' 'B.1.586' 'B.1.1.416' 'B.1.1.98' 'B.1.1.379' + 'B.1.1.360' 'B.1.1.365' 'B.1.1.149' 'B.1.1.374' 'B.1.1.408' 'B.1.287' + 'B.1.298' 'B.1.366' 'B.1.117' 'B.1.304' 'B.1.355' 'B.1.451' 'B.1.334' + 'B.1.289' 'B.1.310' 'B.1.1.144' 'B.1.1.51' 'B.1.1.283' 'B.1.1.111' + 'B.1.1.228' 'B.1.1.58' 'B.1.1.325' 'B.1.1.380' 'B.1.1.362' 'B.1.1.395' + 'B.1.1.244' 'B.1.1.345' 'B.1.1.49' 'B.1.1.312' 'B.1.1.114' 'B.1.1.113' + 'B.1.1.285' 'B.1.1.162' 'B.1.1.210' 'B.1.1.48' 'B.1.407']","[0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 + 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 + 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 + 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 + 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 + 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 + 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 0.01111111 + 0.01111111 0.01111111 0.01111111 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 0.00174216 + 0.00174216 0.00174216]",1.0000000000284284 +SRR12530461,SRR12530461,B.1.1.431,20B,PASS,584532,584532,1155714,5371.18,99.5686,27717,241.3,241.3,16,0,1,2140,0,27725,29865,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,46.441701,mediocre,0.5,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.09,Usher placements: B.1.1(1/2) B.1.1.431(1/2),"[('Other', 0.9712078109855911)]","['B.1.1.309' 'B.1.1.402' 'B.1.1.174' 'B.1.1.274' 'B.1.1.192' 'B.1.1.283' + 'B.1.1.89' 'B.1.1.194' 'B.1.1.43' 'B.1.1.50']","[0.91565413 0.02588621 0.00908791 0.00819672 0.00288913 0.00257625 + 0.00225225 0.00217166 0.00127038 0.00122316]",3.588358624869941 +SRR16298168,SRR16298168,A,19B,PASS,331747,331747,653634,2920.05,98.659,28926,157.8,157.7,3,0,1,878,0,28931,29809,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,4.582771,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: A(1/1),"[('A', 0.9979703920018479)]",['A'],[0.99797039],1.3322450111430808 +SRR16298165,SRR16298165,Unassigned,19B,PASS,533855,533855,1059492,4104.92,44.7781,10935,158.5,158.6,6,46,46,15977,0,10918,26895,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,3371.307668,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.63,,"[('Other', 0.9909744185903079)]",['B.1.1.348'],[0.99097442],2.9515182565245404 +ERR5181360,ERR5181360,B.1.525,21D (Eta),PASS,1500457,1500457,2988662,18562.9,99.8763,29748,400.0,400.1,34,0,0,212,0,29665,29877,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,Eta (B.1.525-like),1.0,0.0,scorpio call: Alt alleles 16; Ref alleles 0; Amb alleles 0; Oth alleles 0,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Eta', 0.9989565798407442)]",['B.1.525'],[0.99895658],6.098845874755646 +ERR5743043,ERR5743043,B.1.617.2,21J (Delta),PASS,1890053,1890053,3772972,23492.7,99.7659,29659,392.6,392.6,34,0,0,254,0,29567,29821,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,Delta (B.1.617.2-like),0.92,0.0,scorpio call: Alt alleles 12; Ref alleles 0; Amb alleles 1; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.617.2(1/1),"[('Delta', 0.9872838003780904)]",['AY.1'],[0.9872838],2.2325768259673464 +SRR16298162,SRR16298162,Unassigned,,,15303,15303,16538,17.0834,99.2476,0,123.3,123.9,0,2,89,29798,0,0,29798,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,,,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9999999999939655)]",['B.1.400.1' 'B' 'B.1' 'B.1.400' 'B.1.399'],[0.333333 0.333333 0.2 0.095238 0.038096],4.670391385229138 +SRR13089080,SRR13089080,B.1.589,20C,PASS,37630,37630,56160,396.898,99.7358,29110,404.4,405.1,9,0,0,705,0,29119,29824,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,2.250000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.04,Usher placements: B.1.589(1/1),"[('Other', 1.000000000000039)]",['B.1.589' 'B.1.37' 'B.1.22' 'B.1.306' 'B.1.81' 'B.1.439'],[0.993624 0.00159236 0.00138636 0.001221 0.00108814 0.00108814],0.7376503496553999 +SRR13486908,SRR13486908,B.1.385,20A,PASS,3297513,3297513,6323766,15199.4,100,29870,258.4,258.4,17,0,0,33,0,29870,29903,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,6.250000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9976877818251184)]",['B.1.385'],[0.99768778],3.6691979037834086 +SRR13358209,SRR13358209,B.1.1.440,20B,PASS,35450,35450,69674,324.219,99.8294,25955,148.7,148.7,6,0,1,3836,0,26029,29865,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,171.512977,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.14,Usher placements: B.1.1.440(1/1),"[('Other', 0.9999999999998432)]",['B.1.1.440'],[1.],0.39529337661549474 +ERR5749609,ERR5749609,B.1.617.2,21J (Delta),PASS,2323723,2323723,4641922,28881.5,99.9799,29770,392.1,392.1,35,0,0,282,0,29604,29886,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,Delta (B.1.617.2-like),1.0,0.0,scorpio call: Alt alleles 13; Ref alleles 0; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.617.2(1/1),"[('Delta', 0.9889110018051883)]",['AY.46' 'AY.88'],[0.98782184 0.00108916],2.296855866833 +SRR13668148,SRR13668148,Unassigned,20C,PASS,200629,200629,343466,1570.58,99.271,23970,151.5,151.5,9,0,0,5890,0,24004,29894,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,428.643347,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.2,,"[('Other', 0.9986500000000043)]",['B.1.570'],[0.99865],0.7338934309274319 +SRR12661075,SRR12661075,B.1.452,20C,PASS,3399069,3399069,6783688,28944.7,100,29844,181.1,181.1,8,0,0,58,0,29845,29903,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9870493278928835)]",['B.1.452'],[0.98704933],0.43843875752249817 +ERR5771988,ERR5771988,B.1.617.1,21B (Kappa),PASS,1111192,1111192,2219762,13813,99.7927,29490,392.3,392.3,29,1,1,383,0,29489,29872,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.094499,good,0.0,,B.1.617.1-like,1.0,0.0,scorpio call: Alt alleles 11; Ref alleles 0; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.617.1(1/1),"[('Kappa', 0.9996870000007768)]",['B.1.617.1'],[0.999687],0.9939326179611652 +SRR11577968,SRR11577968,B.1.320,20C,PASS,436687,436687,865216,4094.85,99.8361,29681,256.6,256.7,7,0,0,172,0,29682,29854,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.320(1/1),"[('Other', 0.9928212689994256)]",['B.1.320'],[0.99282127],0.6576551493680969 +SRR11915959,SRR11915959,B.35,19A,PASS,553601,553601,1077732,5078.15,99.8595,28852,238.8,238.9,8,0,1,991,3,28869,29863,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,15.549808,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: B.35(1/1),"[('Other', 0.9877866600028118)]",['B.35' 'B.1.36.21'],[0.98671 0.00107666],7.69176737596837 +ERR5405022,ERR5405022,B.1.1.7,"20I (Alpha, V1)",PASS,154545,154545,302416,1356.24,99.7258,28386,188.7,188.7,37,0,0,1399,0,28406,29805,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,16.567915,good,0.0,,Alpha (B.1.1.7-like),0.96,0.04,scorpio call: Alt alleles 22; Ref alleles 1; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.1.7(4/4),"[('Alpha', 0.9990475239927775)]",['Q.1' 'B.1.1.7'],[0.99692152 0.002126 ],5.884881902880849 +ERR5743893,ERR5743893,B.1.617.1,21B (Kappa),PASS,198314,198314,396010,1936.44,98.6991,27705,386.5,386.5,23,1,1,2100,0,27705,29805,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,44.444444,mediocre,0.0,,B.1.617.1-like,1.0,0.0,scorpio call: Alt alleles 11; Ref alleles 0; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: B.1.617.1(6/6),"[('Kappa', 0.9999999999997522)]",['B.1.617.1'],[1.],1.175899227487223 +SRR13422799,SRR13422799,B.1.429,21C (Epsilon),PASS,76082,76082,148696,1086.76,99.8261,29256,383.3,383.6,31,0,1,595,0,29256,29851,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,5.534036,good,0.0,,Epsilon (B.1.429-like),1.0,0.0,scorpio call: Alt alleles 14; Ref alleles 0; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.429(1/1),"[('Epsilon', 0.9982520000063589)]",['B.1.429'],[0.998252],9.753255048501465 +SRR13511054,SRR13511054,B.1.526,21F (Iota),PASS,102908,102908,202016,1486.93,99.8361,29772,384.9,385.1,22,0,0,72,0,29772,29844,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,2.777778,good,0.0,,Iota (B.1.526-like),0.83,0.17,scorpio call: Alt alleles 19; Ref alleles 4; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.526(4/4),"[('Iota', 0.9981129999998684)]",['B.1.526'],[0.998113],2.628319486758956 +SRR13126740,SRR13126740,Unassigned,20A,PASS,33706,33706,66504,312.998,98.0537,22433,151.1,151.1,4,0,8,7384,1,22480,29865,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,689.382112,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.26,,"[('Other', 0.9999999999960559)]",['B.1.384' 'B.1.35' 'B.1.157' 'B.1.151' 'B.1.210'],[0.98613381 0.00411523 0.00393701 0.00299401 0.00281994],0.3990966430690064 +ERR5691945,ERR5691945,B.1.351,"20H (Beta, V2)",PASS,1735046,1735046,3464980,21560.2,99.9799,29546,392.5,392.5,26,0,0,419,0,29462,29881,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.194252,good,0.0,,Beta (B.1.351-like),0.86,0.0,scorpio call: Alt alleles 12; Ref alleles 0; Amb alleles 0; Oth alleles 2,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.351(1/1),"[('Beta', 0.9986045313180938)]",['B.1.351'],[0.99860453],4.753249407267848 +SRR16298171,SRR16298171,B.1,20C,FAIL,356628,356628,705516,2656.32,94.5424,25742,155.1,155.1,33,2,4,4114,1,25764,29879,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,854.882061,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.15,Usher placements: B.1(2/2),"[('Other', 0.9763041870486119)]",['B.1.344' 'B.1.302' 'B.1.355' 'B.1.360' 'B.1.453'],[0.96969623 0.0021978 0.00165153 0.00138122 0.00137741],8.943324146626848 +SRR13195337,SRR13195337,B.1.309,20C,PASS,2277602,2277602,4496360,14588.3,99.7425,29804,114.4,114.4,14,0,0,28,0,29798,29826,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9983173691080496)]",['B.1.309'],[0.99831737],0.769427151240039 +SRR13195265,SRR13195265,B.1.1.205,20B,PASS,1946500,1946500,3840040,11784.8,99.7191,29766,105.3,105.3,9,0,0,50,0,29769,29819,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.205(1/1),"[('Other', 0.9945604781945122)]",['B.1.1.205'],[0.99456048],0.7612632370434294 +SRR11494584,SRR11494584,B.4.5,19A,PASS,604651,604651,1192916,5632.64,99.7492,29782,244.2,244.2,5,0,0,46,0,29782,29828,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.99674885100588)]",['B.4.5'],[0.99674885],1.8945239605280295 +SRR16298169,SRR16298169,Unassigned,19B,PASS,223543,223543,442810,1527.85,91.9506,19494,157.2,157.2,3,4,14,10190,1,19536,29727,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,1342.729767,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.35,,"[('A', 0.9987905579991476)]",['A'],[0.99879056],1.943143662371435 +SRR13129709,SRR13129709,D.3,20B,PASS,568486,568486,1112336,5076.84,99.8328,29568,218.4,218.4,14,0,0,285,0,29568,29853,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: D.3(1/1),"[('Other', 0.9960272810336468)]",['D.3'],[0.99602728],0.7781163925082752 +SRR13606410,SRR13606410,P.2,20B,PASS,92107,92107,182852,1313.67,99.7358,29782,382.8,383.0,20,0,0,42,0,29782,29824,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,Zeta (P.2-like),0.86,0.14,scorpio call: Alt alleles 6; Ref alleles 1; Amb alleles 0; Oth alleles 0,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Zeta', 0.9987150003099584)]",['P.2'],[0.998715],2.3486979738854465 +SRR13297857,SRR13297857,B.1.450,20C,PASS,51105,51105,55578,381.584,99.6756,26680,388.2,388.6,4,0,0,3068,0,26738,29806,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,105.100466,bad,0.5,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.12,Usher placements: B.1(1/2) B.1.450(1/2),"[('Other', 0.9996872299908534)]","['B.1.450' 'B.1.360' 'B.1.597' 'B.1.287' 'B.1.431' 'B.1.513' 'B.1.306' + 'B.1.1.164' 'B.1.1.61' 'B.1.334' 'B.1.1.213' 'B.1.1.142' 'B.1.557' + 'B.1.1.378' 'N.7' 'B.1.462' 'B.1.433']","[0.657343 0.30284586 0.00455581 0.00384615 0.00371747 0.00367647 + 0.00358423 0.00301205 0.00274725 0.0022779 0.0022779 0.00220751 + 0.00188324 0.00180102 0.0013089 0.00130208 0.00130039]",1.1109265475364385 +SRR13527262,SRR13527262,Unassigned,20B,PASS,209689,209689,418656,1826.79,97.9266,24895,184.7,184.7,11,1,4,4967,0,24932,29899,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,298.777627,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.18,,"[('Other', 0.9995423819695216)]",['B.1.1.450'],[0.99954238],0.3901851568585231 +SRR12733606,SRR12733606,B.1.390,20A,PASS,776002,776002,1407648,667.97,99.9231,29301,204.4,204.5,7,0,0,585,1,29311,29897,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,2.114198,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.390(1/1),"[('Other', 0.9991303100101582)]",['B.1.390' 'B.1.557'],[0.997379 0.00175131],1.354028274009864 +SRR12833927,SRR12833927,B.1.1.514,20B,PASS,1287220,1287220,2567540,11353.4,98.853,29478,191.5,191.5,8,0,1,95,0,29478,29573,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.514(1/1),"[('Other', 0.999245753102732)]",['B.1.1.514'],[0.99924575],0.5380864050933041 +SRR12763543,SRR12763543,B.1.1.463,20B,PASS,1236202,1236202,2465766,10439.4,99.1907,27649,181.4,181.4,7,0,3,2245,0,27650,29895,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,51.893347,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: B.1.1.463(1/1),"[('Other', 0.9780514169544394)]",['B.1.1.463' 'B.1.1.438'],[0.97697615 0.00107527],0.5252772719322716 +SRR16298160,SRR16298160,Unassigned,20A,PASS,14341,14341,28322,113.449,96.1342,11528,173.3,173.6,5,7,37,18104,0,11608,29712,fastp 0.20.0,minimap2 : 2.24-r1122,samtools ampliconclip : samtools 1.15,iVar version 1.3.1,NC_045512,-,4348.181289,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.61,,"[('Other', 0.9999999999979716)]",['B.1.243'],[1.],1.5053906900647784 diff --git a/data/uphl_datasets_summary.csv b/data/uphl_datasets_summary.csv index 063c14d..6ca553a 100644 --- a/data/uphl_datasets_summary.csv +++ b/data/uphl_datasets_summary.csv @@ -1,75 +1,344 @@ -sample_id,sample,pangolin_lineage,nextclade_clade,fastqc_raw_reads_1,fastqc_raw_reads_2,seqyclean_pairs_kept_after_cleaning,seqyclean_percent_kept_after_cleaning,depth_after_trimming,1X_coverage_after_trimming,num_pos_100X,insert_size_before_trimming,insert_size_after_trimming,%_human_reads,percent_Severe_acute_respiratory_syndrome-related_coronavirus_reads,ivar_num_variants_identified,bedtools_num_failed_amplicons,samtools_num_failed_amplicons,num_N,num_degenerage,num_non-ambiguous,num_total,cleaner_version,aligner_version,trimmer_version,ivar_version,nextclade_qc.overallScore,nextclade_qc.overallStatus,pangolin_scorpio_call,pangolin_version,pangolin_pangolin_version,pangolin_pangoLEARN_version,pangolin_pango_version,pangolin_status -SRR12192434,SRR12192434,B.1,20C,22164,22164,18803,84.8358,149.7,99.9599,25339,189.6,190.9,3.36,96.25,4,0,0,4352,0,25539,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,225.222277,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13690340,SRR13690340,B.1.232,20A,333889,333889,301041,90.162,2691.74,100,29576,200.3,200.4,0,99.95,18,0,0,327,1,29575,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3.787778,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR12733606,SRR12733606,B.1.390,20A,776002,776002,653607,84.2275,636.733,99.9799,29273,203.4,204.3,0.79,15.70,7,0,0,614,1,29282,29897,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,2.352483,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13193342,SRR13193342,B.1.578,20C,78530,78530,74227,94.5206,1060.37,99.7759,29310,565.5,561.0,0.36,99.53,10,0,0,509,0,29327,29836,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.599191,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298166,SRR16298166,None,,6343,6343,69,1.08781,0.00344447,0.344447,0,100.0,0.0,1.45,1.45,0,98,98,7101,0,0,7101,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR13001544,SRR13001544,B.1.199,20A,152965,152965,145024,94.8086,1995.34,99.8796,29805,379.3,381.2,0.05,99.77,6,0,0,62,0,29805,29867,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13668148,SRR13668148,B.1.551,20C,200629,200629,161505,80.4993,1492.37,98.9901,23317,154.4,155.4,0.89,97.20,10,0,0,6548,0,23346,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,535.493882,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298168,SRR16298168,A,19B,331747,331747,299640,90.3218,2780.74,98.8229,28845,162.9,163.1,4.83,94.89,3,1,1,942,0,28855,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,5.653827,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298174,SRR16298174,None,,148231,148231,134328,90.6207,0.360766,19.2355,0,62.3,127.6,99.45,0.03,0,98,98,29440,0,0,29440,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR12162365,SRR12162365,B.1.1.136,20B,258545,258545,244155,94.4342,2036.28,99.6756,29564,190.6,190.9,0,99.92,9,0,0,242,0,29564,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13297857,SRR13297857,B.1.450,20C,51105,51105,25421,49.7427,372.05,99.6756,26404,387.4,388.3,0.22,99.40,4,0,0,3192,0,26614,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,114.727901,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298157,SRR16298157,None,,1691,1691,48,2.83856,0,0,0,0.0,0.0,0,0,0,98,98,0,0,0,0,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR16298163,SRR16298163,None,,162,162,136,83.9506,0.970204,40.3739,0,123.1,125.1,0,99.26,0,98,98,29677,0,0,29677,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR13690003,SRR13690003,B.1.2,20C,753605,753605,706369,93.732,6275.35,99.9632,29597,198.1,198.3,0.00,99.93,18,0,0,296,7,29590,29893,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,49.000000,mediocre,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13195337,SRR13195337,B.1.309,20C,2277602,2277602,1320912,57.9957,9910.91,99.6489,29782,143.4,144.3,0,99.79,14,0,0,16,0,29782,29798,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR12530461,SRR12530461,B.1.1.431,20B,584532,584532,575787,98.5039,4994.48,99.4649,27617,239.2,239.7,0.00,99.85,16,0,1,2247,0,27617,29864,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,52.000123,mediocre,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -ERR5771988,ERR5771988,B.1.617.1,21B (Kappa),1111192,1111192,1107889,99.7028,13336.6,99.7826,29512,391.6,391.7,0,99.96,28,1,1,2618,0,27253,29871,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,73.705405,mediocre,B.1.617.1-like,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -ERR5181360,ERR5181360,B.1.525,21D (Eta),1500457,1500457,1492260,99.4537,17923,99.8361,29746,398.8,398.5,0,99.96,32,0,0,2195,0,27633,29828,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,49.259602,mediocre,Eta (B.1.525-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -ERR5691945,ERR5691945,B.1.351,"20H (Beta, V2)",1735046,1735046,1723717,99.347,20605.5,99.9766,29569,390.9,391.2,0,99.89,23,0,1,7666,0,22215,29881,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,744.279232,bad,Beta (B.1.351-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13089080,SRR13089080,B.1.589,20C,37630,37630,26337,69.9894,381.88,99.7358,28855,403.9,402.7,0.06,99.83,9,0,0,900,0,28924,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,4.938272,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -ERR5743893,ERR5743893,B.1.617.1,21B (Kappa),198314,198314,166710,84.0637,1821.9,98.8095,27600,386.5,386.8,0.00,93.25,23,1,1,2246,0,27626,29872,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,51.946722,mediocre,B.1.617.1-like,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR11577968,SRR11577968,B.1.320,20C,436687,436687,433315,99.2278,3908.91,99.7693,29624,254.3,254.5,0,99.90,7,0,0,207,0,29627,29834,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13526755,SRR13526755,B.1.1.418,20B,1068040,1068040,968596,90.6891,8293.36,99.8997,29782,179.7,179.9,0.00,99.95,18,0,0,91,0,29782,29873,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13195265,SRR13195265,B.1.1.205,20B,1946500,1946500,1035164,53.1808,7529.44,99.5954,29567,134.7,135.9,0.00,99.69,9,0,0,194,0,29588,29782,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR12833718,SRR12833718,B.1.1.174,20B,651160,651160,606671,93.1677,5205.77,97.211,27112,185.8,186.2,0,99.88,14,0,3,2433,8,27120,29561,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,126.583611,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR12763543,SRR12763543,B.1.1.463,20B,1236202,1236202,1093951,88.4929,9470.23,99.1941,27551,187.4,187.5,0.00,99.92,7,0,5,2340,0,27555,29895,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,57.086420,mediocre,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13486908,SRR13486908,B.1.385,20A,3297513,3297513,3038569,92.1473,14336,100,29869,256.6,257.5,0.27,76.24,17,0,0,34,0,29869,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1.562500,good,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13527262,SRR13527262,B.1.1.450,20B,209689,209689,193935,92.487,1687.27,97.4016,24644,185.8,186.0,0,99.96,11,1,6,5232,0,24667,29899,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,333.671111,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13422802,SRR13422802,B.1.427,21C (Epsilon),146635,146635,139244,94.9596,1865.65,99.3445,29363,382.9,383.8,0.17,99.60,19,0,0,443,0,29363,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.280508,good,Epsilon (B.1.427-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298169,SRR16298169,None,19B,223543,223543,207555,92.8479,1460.08,91.7968,19275,145.8,159.1,0.87,89.87,3,5,14,10413,1,19312,29726,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1403.918642,bad,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR11915959,SRR11915959,B.35,19A,553601,553601,542581,98.0094,4599.47,99.8529,28759,235.3,235.7,0.00,99.78,8,0,1,1105,5,28756,29866,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,33.889232,mediocre,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13129709,SRR13129709,D.3,20B,568486,568486,555853,97.7778,4611.04,99.8328,29547,215.9,216.2,0,99.84,14,0,0,304,0,29549,29853,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000219,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298162,SRR16298162,None,,15303,15303,3518,22.989,15.7096,99.1707,0,124.0,127.2,32.69,64.18,0,3,92,29782,0,0,29782,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR12901576,SRR12901576,B.1.515,20C,363267,363267,354907,97.6987,3151.37,99.3914,28880,254.8,254.7,0.05,99.91,7,0,0,1012,0,28888,29900,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,6.953964,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR12833927,SRR12833927,B.1.1.514,20B,1287220,1287220,1210340,94.0274,10624,98.7493,29470,190.6,190.8,0.00,99.90,8,0,1,88,0,29473,29561,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298172,SRR16298172,None,19A,2604,2604,2452,94.1628,20.6813,99.7826,211,197.4,198.9,0,99.92,0,2,86,29617,0,221,29838,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,11789.938121,bad,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -ERR5743043,ERR5743043,AY.43,21J (Delta),1890053,1890053,1883051,99.6295,22727.6,99.99,29639,391.8,391.9,0,99.95,26,0,0,9105,0,20789,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1063.484568,bad,Delta (B.1.617.2-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298165,SRR16298165,None,20B,533855,533855,499859,93.632,3900.34,43.3134,10764,158.6,158.8,0,99.94,6,48,46,16112,0,10770,26882,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3429.620631,bad,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -ERR5556343,ERR5556343,P.1,"20J (Gamma, V3)",216817,216817,215689,99.4797,2590.21,99.6656,27915,385.5,385.7,0.00,99.81,32,0,0,1838,0,27964,29802,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,32.447791,mediocre,Gamma (P.1-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13062553,SRR13062553,B.1.265,20C,20718,20718,19623,94.7147,286.989,99.7759,27878,391.0,390.9,0.01,99.95,6,0,0,1934,0,27902,29836,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,36.624911,mediocre,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR12212912,SRR12212912,B.1.112,20A,274115,274115,267908,97.7356,2458.45,99.893,29415,267.4,267.3,0.12,99.86,10,0,0,480,0,29423,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.444444,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298164,SRR16298164,None,,37159,37159,36931,99.3864,0.0650102,4.07651,0,166.6,176.8,97.48,0.02,0,98,98,29849,0,0,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR16298173,SRR16298173,B,19A,138431,138431,125512,90.6676,993.646,93.4455,25104,166.8,167.0,0.00,99.51,0,1,1,4733,1,25104,29838,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,270.567750,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13606410,SRR13606410,P.2,20B,92107,92107,87333,94.8169,1219.75,99.7358,29805,381.5,383.0,0.08,99.86,20,0,0,19,0,29805,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,Zeta (P.2-like),PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR12774785,SRR12774785,B.1,20C,29696,29696,27583,92.8846,250.013,98.8663,24539,150.6,150.9,0.00,99.91,7,0,4,5293,1,24597,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,342.975981,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13004400,SRR13004400,B.1.264,20C,34961,34961,32748,93.6701,478.153,99.7659,28339,384.1,385.2,0.20,99.28,7,0,0,1472,0,28361,29833,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,18.842030,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR11494584,SRR11494584,B.4.5,19A,604651,604651,598174,98.9288,5163.91,99.7425,29782,241.0,241.3,0,99.82,5,0,0,44,0,29782,29826,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -ERR5181310,ERR5181310,B.1.525,21D (Eta),912571,912571,909776,99.6937,10999.1,99.6154,29734,391.7,391.9,0,99.96,35,0,0,67,0,29732,29799,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,Eta (B.1.525-like),PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13422799,SRR13422799,B.1.429,21C (Epsilon),76082,76082,72210,94.9108,954.433,99.8462,29253,381.3,382.2,0.07,99.79,31,0,1,638,0,29253,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1.567133,good,Epsilon (B.1.429-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13373851,SRR13373851,B.1.492,20C,184210,184210,169443,91.9836,1553.81,99.6455,29661,152.8,153.1,0.16,99.21,8,0,0,129,0,29668,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13689874,SRR13689874,B.1.1.512,20B,301254,301254,291105,96.6311,2601.95,99.8896,29512,224.9,225.1,0,99.91,27,0,0,389,0,29513,29902,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,21.115600,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298175,SRR16298175,None,19A,142646,142646,132133,92.63,170.294,59.7331,6164,155.9,156.4,81.84,16.78,2,53,66,23682,0,6167,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,7499.560000,bad,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR13433883,SRR13433883,B.1.258.23,20A,106223,106223,103545,97.4789,892.565,99.8662,28371,275.6,275.6,0.01,99.96,25,0,3,1515,0,28378,29893,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,20.250000,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298170,SRR16298170,A,19B,606680,606680,554256,91.3589,4298.65,89.0279,24881,163.2,163.5,0.20,99.70,3,2,2,4931,0,24881,29812,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,294.186022,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298158,SRR16298158,None,20A,300310,300310,268801,89.5078,755.487,40.4541,5484,143.4,143.9,61.49,37.36,8,68,71,24379,1,5483,29863,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,8010.586639,bad,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR13574337,SRR13574337,B.1.375,20C,1245538,1245538,1053080,84.5482,1554.99,99.9933,29827,284.4,285.4,20.22,23.76,15,0,0,71,0,29826,29897,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13511054,SRR13511054,B.1.526,21F (Iota),102908,102908,98829,96.0363,1368.17,99.7693,29795,383.9,384.5,0.01,99.95,22,0,0,29,0,29795,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,Iota (B.1.526-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13687078,SRR13687078,B.1.1.362,20B,33826,33826,31549,93.2685,296.485,99.5118,26782,155.2,155.6,0.03,99.89,9,0,1,3068,0,26828,29896,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,105.100466,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR12751757,SRR12751757,D.2,20F,497470,497470,492069,98.9143,4292.07,97.5186,24044,210.7,211.1,0.00,99.88,14,0,3,5787,1,24061,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,413.992716,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298159,SRR16298159,None,,27131,27131,21036,77.5349,0.253821,15.266,0,93.6,151.4,97.65,0.15,0,98,98,29069,0,0,29069,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR14241199,SRR14241199,B.1.526,21F (Iota),222498,222498,200666,90.1878,2842.08,99.9164,28449,385.7,385.8,0.04,98.96,25,0,0,1423,0,28449,29872,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,17.299438,good,Iota (B.1.526-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13500958,SRR13500958,P.2,20B,73899,73899,69791,94.4411,964.395,99.7659,28015,379.9,381.4,1.85,96.76,22,0,0,1797,0,28036,29833,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,30.740864,mediocre,Zeta (P.2-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13603869,SRR13603869,B.1.427,21C (Epsilon),35473,35473,33496,94.4267,316.52,98.3982,24179,156.6,156.8,0.01,99.92,14,1,5,5657,0,24192,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,393.654993,bad,Epsilon (B.1.427-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13126740,SRR13126740,B.1,20A,33706,33706,31563,93.6421,283.858,97.6257,21822,152.3,152.9,0.00,99.92,4,0,10,7916,0,21880,29796,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,795.657833,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -ERR5405022,ERR5405022,B.1.1.7,"20I (Alpha, V1)",154545,154545,151242,97.8628,1236.53,99.7525,28291,182.4,182.9,0,99.85,35,0,0,1512,0,28300,29812,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,20.150123,good,Alpha (B.1.1.7-like),PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298161,SRR16298161,None,20C,188463,188463,164636,87.3572,822.63,66.5351,12630,130.3,130.6,30.27,68.96,12,26,39,16440,0,12636,29076,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3629.632716,bad,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR13358209,SRR13358209,B.1.1.440,20B,35450,35450,32711,92.2736,299.735,99.6455,25247,151.7,152.1,0.01,99.91,6,0,3,4476,0,25321,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,239.217778,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298167,SRR16298167,None,,1330,1330,96,7.21805,0.0167207,1.21393,0,363.0,363.0,0,1.04,0,98,98,363,0,0,363,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR16298171,SRR16298171,B.1,20C,356628,356628,326814,91.64,2481.3,94.0006,25675,155.1,155.3,0.02,99.39,33,2,4,4177,2,25700,29879,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,817.132771,bad,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR13297853,SRR13297853,B.1.323,20C,372300,372300,316829,85.1005,4575,99.9197,29805,535.7,533.3,0.18,98.18,7,0,0,74,0,29805,29879,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -SRR16298160,SRR16298160,None,20A,14341,14341,13508,94.1915,108.457,95.7295,11093,173.5,173.8,0.20,99.73,5,8,38,18527,0,11177,29704,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,4557.250055,bad,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR13195052,SRR13195052,B.1.1.139,20B,416419,416419,387426,93.0375,3289.94,99.9732,29621,195.8,196.2,0.00,99.72,10,0,0,269,0,29633,29902,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PLEARN-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc -ERR5749609,ERR5749609,None,21J (Delta),2323723,2323723,2315943,99.6652,27728,99.9833,29729,391.3,391.4,0,99.96,26,0,0,10326,1,19567,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1379.884444,bad,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,fail -SRR12661075,SRR12661075,B.1.452,20C,3399069,3399069,3018507,88.8039,26574.4,100,29815,187.6,187.7,0,99.94,8,0,0,88,0,29815,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,,PANGO-v1.2.121,3.1.17,2022-01-05,v1.2.121,passed_qc +sample_id,sample,pangolin_lineage,nextclade_clade,fastqc_raw_reads_1,fastqc_raw_reads_2,seqyclean_pairs_kept_after_cleaning,seqyclean_percent_kept_after_cleaning,depth_after_trimming,1X_coverage_after_trimming,num_pos_100X,insert_size_before_trimming,insert_size_after_trimming,%_human_reads,percent_Severe_acute_respiratory_syndrome-related_coronavirus_reads,ivar_num_variants_identified,bedtools_num_failed_amplicons,samtools_num_failed_amplicons,num_N,num_degenerage,num_non-ambiguous,num_total,cleaner_version,aligner_version,trimmer_version,ivar_version,nextclade_qc.overallScore,nextclade_qc.overallStatus,pangolin_conflict,pangolin_ambiguity_score,pangolin_scorpio_call,pangolin_scorpio_support,pangolin_scorpio_conflict,pangolin_scorpio_notes,pangolin_version,pangolin_pangolin_version,pangolin_scorpio_version,pangolin_constellation_version,pangolin_is_designated,pangolin_qc_status,pangolin_qc_notes,pangolin_note,freyja_summarized,freyja_lineages,freyja_abundances,freyja_resid +SRR13358209,SRR13358209,B.1.1.440,20B,35450,35450,32711,92.2736,299.735,99.6455,25247,151.7,152.1,0.01,99.91,6,0,3,4476,0,25321,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,239.217778,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.16,Usher placements: B.1.1.440(1/1),"[('Other', 0.9999999999997261)]",['B.1.1.440'],[1.],0.37655257754829174 +SRR16298163,SRR16298163,Unassigned,,162,162,136,83.9506,0.970204,40.3739,0,123.1,125.1,0,99.26,0,98,98,29677,0,0,29677,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9999999999986484)]","['B.1.36.38' 'B.1.320' 'B.1.431' 'B.1.39' 'B.1.489' 'B.1.302' 'B.1.453' + 'B.1.572' 'B.1.324' 'B.1.510' 'B.1.570' 'B.1.344' 'B.1.520' 'B.1.513' + 'B.1.319' 'B.1.321' 'B.1.413' 'B.1.294' 'B.1.437' 'B.1.428' 'B.1.298' + 'B.1.304' 'B.1.428.3' 'B.1.428.1' 'B.1.491' 'B.1.44' 'B.1.314' 'B.1.576' + 'B.1.533' 'B.1.40' 'B.1.340' 'B.1.582' 'B.1.349' 'B.1.22' 'B.1.586' + 'B.1.362' 'B.1.334' 'B.1.267']","[0.03656824 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 0.0260387 + 0.0260387 0.0260387 ]",2.493450309757139 +ERR5743893,ERR5743893,B.1.617.1,21B (Kappa),198314,198314,166710,84.0637,1821.9,98.8095,27600,386.5,386.8,0.00,93.25,23,1,1,2246,0,27626,29872,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,51.946722,mediocre,0.0,,B.1.617.1-like,1.0,0.0,scorpio call: Alt alleles 11; Ref alleles 0; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: B.1.617.1(6/6),"[('Kappa', 0.9999999999997385)]",['B.1.617.1'],[1.],1.198380375868782 +SRR13422802,SRR13422802,B.1.427,21C (Epsilon),146635,146635,139244,94.9596,1865.65,99.3445,29363,382.9,383.8,0.17,99.60,19,0,0,443,0,29363,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.280508,good,0.0,,Epsilon (B.1.427-like),0.92,0.0,scorpio call: Alt alleles 12; Ref alleles 0; Amb alleles 1; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.427(1/1),"[('Epsilon', 0.998269999996965)]",['B.1.427'],[0.99827],2.5932039829313354 +SRR13297857,SRR13297857,B.1.450,20C,51105,51105,25421,49.7427,372.05,99.6756,26404,387.4,388.3,0.22,99.40,4,0,0,3192,0,26614,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,114.727901,bad,0.5,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.12,Usher placements: B.1(1/2) B.1.450(1/2),"[('Other', 0.9996290499951919)]","['B.1.450' 'B.1.360' 'B.1.597' 'B.1.431' 'B.1.513' 'B.1.306' 'B.1.1.164' + 'B.1.1.61' 'B.1.334' 'B.1.1.213' 'B.1.1.142' 'B.1.557' 'B.1.1.378' + 'B.1.462' 'N.7' 'B.1.433']","[0.664336 0.29961458 0.00455581 0.00371747 0.0037037 0.00362319 + 0.00303951 0.00277008 0.0022779 0.00226757 0.00220264 0.0019305 + 0.00167159 0.00131579 0.00131406 0.00128866]",1.082816574634727 +SRR13689874,SRR13689874,B.1.1.512,20B,301254,301254,291105,96.6311,2601.95,99.8896,29512,224.9,225.1,0,99.91,27,0,0,389,0,29513,29902,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,21.115600,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.1.512(1/1),"[('Other', 0.9984619999996437)]",['B.1.1.512'],[0.998462],5.739059699133654 +SRR16298161,SRR16298161,Unassigned,20C,188463,188463,164636,87.3572,822.63,66.5351,12630,130.3,130.6,30.27,68.96,12,26,39,16440,0,12636,29076,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3631.195216,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.58,,"[('Other', 0.9993582950550222)]",['B.1.2'],[0.9993583],1.984753715213297 +SRR13193342,SRR13193342,B.1,20C,78530,78530,74227,94.5206,1060.37,99.7759,29310,565.5,561.0,0.36,99.53,10,0,0,509,0,29327,29836,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.599191,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1(1/1),"[('Other', 0.9981853259988552)]",['B.1.320'],[0.99818533],2.116845179402226 +SRR16298172,SRR16298172,Unassigned,19A,2604,2604,2452,94.1628,20.6813,99.7826,211,197.4,198.9,0,99.92,0,2,86,29617,0,221,29838,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,11789.938121,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.99,,"[('Other', 0.9999999999997088)]",['B'],[1.],1.5916110395553489 +SRR16298159,SRR16298159,Unassigned,,27131,27131,21036,77.5349,0.253821,15.266,0,93.6,151.4,97.65,0.15,0,98,98,29069,0,0,29069,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9978354978326749), ('Zeta', 0.002164502164496045)]","['AZ.4' 'B.1.1.174' 'B.1.1.129' 'B.1.1.57' 'B.1.1.10' 'B.1.1.398' + 'B.1.1.441' 'B.1.1.447' 'B.1.1.175' 'B.1.1.376' 'B.1.1.203' 'B.1.1.500' + 'B.1.1.275' 'B.1.267' 'B.1.315' 'B.1.115' 'B.1.323' 'B.1.294' 'B.1.564' + 'B.1.413' 'B.1.264' 'B.1.321' 'B.1.166' 'B.1.319' 'B.1.513' 'B.1.520' + 'B.1.344' 'B.1.1.185' 'B.1.1.402' 'B.1.320' 'B.1.1.169' 'B.1.1.192' + 'B.1.1.34' 'B.1.1.254' 'B.1.1.166' 'B.1.1.274' 'B.1.1.83' 'B.1.1.372' + 'B.1.1.33' 'B.1.1.43' 'B.1.1.122' 'B.1.1.164' 'B.1.1.200' 'B.1.1.137' + 'B.1.173' 'B.1.1.134' 'B.1.1.118' 'B.1.1.148' 'B.1.1.12' 'B.1.1.168' + 'B.1.1.26' 'B.1.1.485' 'B.1.1.25' 'B.1.1.378' 'B.1.1.440' 'B.1.1.438' + 'B.1.510' 'B.1.485' 'B.1.1.189' 'B.1.530' 'B.1.1.75' 'B.1.1.5' + 'B.1.1.222' 'B.1.1.317' 'B.1.1.220' 'B.1.1.158' 'B.1.1.464' 'B.1.1.8' + 'B.1.1.423' 'B.1.1.17' 'B.1.1.257' 'B.1.1.323' 'B.1.1.458' 'B.1.1.63' + 'B.1.1.45' 'B.1.1.14' 'B.1.1.384' 'B.1.1.130' 'B.1.1.261' 'B.1.1.241' + 'B.1.1.253' 'B.1.1.82' 'B.1.1.204' 'B.1.1.133' 'B.1.1.115' 'B.1.1.404' + 'B.1.232' 'B.1.324' 'B.1.235' 'B.1.572' 'B.1.268' 'B.1.487' 'B.1.108' + 'B.1.489' 'B.1.39' 'B.1.329' 'B.1.330' 'B.1.333' 'B.1.431' 'B.1.511' + 'B.1.483' 'B.1.479' 'B.1.13' 'B.1.274' 'B.1.277' 'B.1.273' 'B.1.478' + 'B.1.139' 'B.1.565' 'B.1.210' 'B.1.408' 'B.1.407' 'B.1.551' 'B.1.402' + 'B.1.1.205' 'B.1.1.71' 'AZ.3' 'B.3.1' 'B.60' 'B.39' 'B.35' 'B.6.6' + 'B.1.67' 'B.1.76' 'B.1.215' 'B.1.8' 'B.1.81' 'B.1.201' 'B.1.395' + 'B.1.383' 'B.1.142' 'B.1.145' 'B.1.143' 'B.1.78' 'B.1.195' 'B.1.134' + 'B.1.545' 'B.1.378' 'B.1.199' 'B.1.91' 'B.1.179' 'B.1.70' 'B.1.377' 'B.1' + 'B.34' 'B.1.194' 'B.32' 'B.15' 'B.20' 'B.1.14' 'B.27' 'B.55' 'B.26' + 'B.23' 'B.6' 'B.47' 'B.57' 'B.11' 'B.10' 'B.42' 'B.45' 'B.12' 'B.28' + 'B.61' 'B.33' 'B.41' 'B.29' 'B.3' 'B.30' 'B.31' 'B.40' 'B.37' 'B.1.187' + 'B.1.543' 'B.1.1.142' 'B.1.248' 'B.1.250' 'B.1.1' 'B.1.382' 'B.1.219' + 'B.1.96' 'B.1.153' 'B.1.393' 'B.1.416' 'B.1.233' 'B.1.229' 'B.1.556' + 'B.1.381' 'B.1.243' 'B.1.239' 'B.1.397' 'B.1.400' 'B.1.238' 'B.1.558' + 'B.1.399' 'B.1.401' 'B.1.240' 'B.1.249' 'B.1.254' 'B.1.252' 'B.1.1.92' + 'B.1.251' 'B.1.104' 'B.58' 'B.1.391' 'B.43' 'B.1.103' 'B.1.178' 'B.1.147' + 'B.1.213' 'B.1.6' 'B.1.151' 'B.1.208' 'B.1.218' 'B.1.205' 'B.1.35' + 'B.1.23' 'B.1.198' 'B.1.390' 'B.1.106' 'B.1.379' 'B.1.182' 'B.1.180' + 'B.1.223' 'B.1.225' 'B.1.420' 'B.1.181' 'B.1.418' 'B.1.415' 'B.1.559' + 'B.1.1.41' 'B.1.1.231' 'B.1.1.310' 'B.1.164' 'B.1.466' 'B.1.456' 'B.1.36' + 'B.1.184' 'B.1.627' 'B.1.398' 'B.1.1.4' 'B.1.1.216' 'B.1.1.29' 'P.7' + 'AH.1' 'AH.2' 'B.1.1.467' 'B.1.1.294' 'B.1.1.344' 'B.1.1.482' 'B.1.1.322' + 'B.1.428.1' 'B.1.428.2' 'B.1.165' 'B.1.521' 'B.1.435' 'B.1.433' 'B.1.9' + 'B.1.443' 'B.1.170' 'B.1.162' 'B.1.36.24' 'B.1.245' 'B.1.1.308' + 'B.1.1.311' 'B.1.1.16' 'B.1.1.239' 'B.1.1.89' 'B.1.1.315' 'B.1.533' + 'B.1.1.136' 'B.1.1.13' 'L.2' 'B.1.1.214' 'B.1.1.226' 'B.1.1.363' + 'B.1.1.373' 'B.1.494' 'B.1.571' 'B.1.120' 'B.1.579' 'B.1.314' 'B.1.448' + 'B.1.596.1' 'B.1.112' 'B.1.439' 'B.1.161' 'B.1.124' 'B.1.36.7' + 'B.1.36.35' 'B.1.1.107' 'B.1.428.3' 'B.1.441' 'B.1.385' 'B.1.9.1' + 'B.1.9.2' 'B.1.9.4' 'B.1.9.5' 'B.1.36.34' 'B.1.36.12' 'B.1.221' + 'B.1.1.348' 'C.23' 'C.36' 'B.1.1.375' 'M.2' 'B.1.1.236' 'AF.1' 'B.1.389' + 'B.1.1.290' 'B.1.400.1' 'B.1.1.277' 'B.1.1.303' 'B.1.562' 'B.1.221.1' + 'B.1.1.318' 'XB' 'B.1.570' 'B.1.564.1' 'B.1.36.8' 'L.4' 'B.1.36.16' + 'B.1.36.1' 'B.1.469' 'B.1.214.3' 'B.1.409' 'B.1.1.523' 'P.6' 'P.2' 'C.35' + 'C.13' 'C.12' 'C.27' 'C.25' 'C.3' 'C.14' 'C.1' 'C.4' 'C.32' 'C.2' + 'B.1.1.269' 'B.1.1.190' 'B.1.1.207' 'B.1.1.161' 'D.4' 'B.1.1.44' + 'B.1.1.159' 'B.1.1.97' 'AN.1' 'B.1.1.210' 'B.1.1.305' 'B.1.1.49' + 'B.1.1.51' 'B.1.1.98' 'B.1.1.379' 'B.1.1.360' 'B.1.1.237' 'B.1.1.365' + 'B.1.1.408' 'B.1.359' 'B.1.493' 'B.1.3' 'B.1.309' 'B.1.496' 'B.1.369' + 'B.1.287' 'B.1.428' 'B.1.515' 'B.1.298' 'B.1.366' 'B.1.304' 'B.1.264.1' + 'B.1.606' 'B.1.452' 'B.1.355' 'B.1.1.48' 'B.1.1.162' 'B.1.1.61' + 'B.1.1.285' 'B.1.1.307' 'B.1.1.116' 'B.1.1.67' 'D.3' 'B.1.1.217' + 'B.1.1.141' 'B.1.1.506' 'B.1.1.46' 'B.1.1.132' 'B.1.1.416' 'B.1.1.266' + 'B.1.1.228' 'B.1.1.58' 'B.1.1.325' 'B.1.1.380' 'B.1.1.362' 'B.1.1.244' + 'B.1.1.177' 'B.1.1.359' 'B.1.1.263' 'B.1.1.461' 'B.1.1.381' 'B.1.1.262' + 'B.1.1.213' 'B.1.1.113' 'B.1.337' 'B.1.168' 'B.1.335' 'B.1.451' 'B.1.97' + 'B.1.1.291' 'B.1.416.1' 'B.1.610' 'B.1.241' 'B.1.405' 'B.1.1.289' + 'B.1.1.459' 'B.1.1.77' 'B.1.1.521' 'B.1.1.368' 'B.1.1.326' 'B.1.1.125' + 'B.1.1.194' 'B.1.1.138' 'B.1.1.38' 'B.1.1.208' 'B.1.1.128' 'B.1.1.55' + 'B.1.1.186' 'B.1.1.1' 'B.59' 'N.4' 'N.3' 'N.1' 'B.1.159' 'B.1.281' + 'B.1.462' 'B.1.22' 'B.1.334' 'B.1.310' 'B.1.586' 'B.1.424' 'B.1.450' + 'B.1.301' 'B.1.265' 'B.1.336' 'B.1.370' 'B.1.590' 'B.1.116' 'B.1.332' + 'B.1.471' 'B.1.293' 'B.1.342' 'B.1.607' 'B.1.372' 'B.1.12' 'B.1.356' + 'B.1.340' 'B.1.492' 'B.1.465' 'B.1.470' 'B.1.523' 'B']","[0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 + 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645 0.0021645]",0.6309297535733255 +SRR13500958,SRR13500958,P.2,20B,73899,73899,69791,94.4411,964.395,99.7659,28015,379.9,381.4,1.85,96.76,22,0,0,1797,0,28036,29833,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,30.740864,mediocre,0.0,,Zeta (P.2-like),0.86,0.14,scorpio call: Alt alleles 6; Ref alleles 1; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: P.2(1/1),"[('Zeta', 0.9999999999989699)]",['P.2'],[1.],2.2156887583671367 +SRR16298169,SRR16298169,Unassigned,19B,223543,223543,207555,92.8479,1460.08,91.7968,19275,145.8,159.1,0.87,89.87,3,5,14,10413,1,19312,29726,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1403.918642,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.36,,"[('A', 0.9988582479988226)]",['A'],[0.99885825],1.9567600856205867 +SRR12212912,SRR12212912,B.1.112,20A,274115,274115,267908,97.7356,2458.45,99.893,29415,267.4,267.3,0.12,99.86,10,0,0,480,0,29423,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.444444,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.112(1/1),"[('Other', 0.9974651030075826)]",['B.1.112'],[0.9974651],0.6090439953290001 +SRR12162365,SRR12162365,B.1.1,20B,258545,258545,244155,94.4342,2036.28,99.6756,29564,190.6,190.9,0,99.92,9,0,0,242,0,29564,29806,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1(1/1),"[('Other', 0.9829944859999504)]","['B.1.1.136' 'B.1.1.402' 'B.1.1.194' 'B.1.1.180' 'B.1.1.57' 'B.1.1.274' + 'B.1.1.148' 'B.1.1.463' 'B.1.1.92']","[0.86641818 0.10617074 0.00277932 0.00157729 0.00143266 0.00129199 + 0.00121951 0.00107066 0.00103413]",1.5339975645038009 +SRR13001544,SRR13001544,B.1.199,20A,152965,152965,145024,94.8086,1995.34,99.8796,29805,379.3,381.2,0.05,99.77,6,0,0,62,0,29805,29867,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9887107280004006)]",['B.1.199' 'B.1.378' 'B.1.545' 'B.1.393'],[0.98461941 0.00187441 0.00118064 0.00103627],0.7294932367468199 +SRR16298157,SRR16298157,Unassigned,,1691,1691,48,2.83856,0,0,0,0.0,0.0,0,0,0,98,98,0,0,0,0,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,,,, +SRR16298166,SRR16298166,Unassigned,,6343,6343,69,1.08781,0.00344447,0.344447,0,100.0,0.0,1.45,1.45,0,98,98,7101,0,0,7101,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,[],[],[],4.1425812798300395e-13 +SRR13297853,SRR13297853,B.1.323,20C,372300,372300,316829,85.1005,4575,99.9197,29805,535.7,533.3,0.18,98.18,7,0,0,74,0,29805,29879,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9941779379912073)]",['B.1.323'],[0.99417794],0.5776928122749417 +SRR13004400,SRR13004400,B.1.264,20C,34961,34961,32748,93.6701,478.153,99.7659,28339,384.1,385.2,0.20,99.28,7,0,0,1472,0,28361,29833,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,18.842030,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.264(1/1),"[('Other', 0.9995227099998779)]",['B.1.264' 'B.1.320'],[0.998175 0.00134771],0.7449484252986486 +SRR13062553,SRR13062553,B.1.265,20C,20718,20718,19623,94.7147,286.989,99.7759,27878,391.0,390.9,0.01,99.95,6,0,0,1934,0,27902,29836,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,36.624911,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: B.1.265(1/1),"[('Other', 0.9999999999999897)]",['B.1.265'],[1.],0.634246919461033 +SRR13089080,SRR13089080,B.1.589,20C,37630,37630,26337,69.9894,381.88,99.7358,28855,403.9,402.7,0.06,99.83,9,0,0,900,0,28924,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,4.938272,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: B.1.589(1/1),"[('Other', 1.0000000000006435)]",['B.1.589' 'B.1.306' 'B.1.37' 'B.1.22' 'B.1.81' 'B.1.439'],[0.99215791 0.00246609 0.00161031 0.00156908 0.00110132 0.00109529],0.6837990260814789 +ERR5405022,ERR5405022,B.1.1.7,"20I (Alpha, V1)",154545,154545,151242,97.8628,1236.53,99.7525,28291,182.4,182.9,0,99.85,35,0,0,1512,0,28300,29812,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,20.150123,good,0.0,,Alpha (B.1.1.7-like),0.96,0.04,scorpio call: Alt alleles 22; Ref alleles 1; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.07,Usher placements: B.1.1.7(4/4),"[('Alpha', 0.9994305239977794)]",['Q.1'],[0.99943052],6.23424681110291 +SRR13511054,SRR13511054,B.1.526,21F (Iota),102908,102908,98829,96.0363,1368.17,99.7693,29795,383.9,384.5,0.01,99.95,22,0,0,29,0,29795,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,2.777778,good,0.0,,Iota (B.1.526-like),0.83,0.17,scorpio call: Alt alleles 19; Ref alleles 4; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.526(4/4),"[('Iota', 0.998442000000223)]",['B.1.526'],[0.998442],2.4611501180739337 +SRR12751757,SRR12751757,Unassigned,20F,497470,497470,492069,98.9143,4292.07,97.5186,24044,210.7,211.1,0.00,99.88,14,0,3,5787,1,24061,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,413.992716,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.2,,"[('Other', 0.999146999999873)]",['D.2'],[0.999147],2.011929144853948 +SRR13668148,SRR13668148,Unassigned,20C,200629,200629,161505,80.4993,1492.37,98.9901,23317,154.4,155.4,0.89,97.20,10,0,0,6548,0,23346,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,535.493882,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.22,,"[('Other', 0.9982710000000012)]",['B.1.570'],[0.998271],0.40891938275289097 +SRR13527262,SRR13527262,Unassigned,20B,209689,209689,193935,92.487,1687.27,97.4016,24644,185.8,186.0,0,99.96,11,1,6,5232,0,24667,29899,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,333.671111,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.19,,"[('Other', 0.997939853000267)]",['B.1.1.450'],[0.99793985],0.44492039882487977 +SRR13373851,SRR13373851,B.1.492,20C,184210,184210,169443,91.9836,1553.81,99.6455,29661,152.8,153.1,0.16,99.21,8,0,0,129,0,29668,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.492(1/1),"[('Other', 0.9992850000000023)]",['B.1.492'],[0.999285],1.1520581202898874 +SRR13126740,SRR13126740,Unassigned,20A,33706,33706,31563,93.6421,283.858,97.6257,21822,152.3,152.9,0.00,99.92,4,0,10,7916,0,21880,29796,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,795.657833,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.28,,"[('Other', 0.9999999999999798)]",['B.1.384'],[1.],0.4250702074217659 +SRR16298168,SRR16298168,A,19B,331747,331747,299640,90.3218,2780.74,98.8229,28845,162.9,163.1,4.83,94.89,3,1,1,942,0,28855,29797,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,5.653827,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: A(1/1),"[('A', 0.9987218409994785)]",['A'],[0.99872184],1.308255849188803 +SRR16298162,SRR16298162,Unassigned,,15303,15303,3518,22.989,15.7096,99.1707,0,124.0,127.2,32.69,64.18,0,3,92,29782,0,0,29782,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.9999999999707732)]",['B.1.400.1' 'B' 'B.1' 'B.1.399'],[0.352941 0.333333 0.254902 0.058824],4.4173170009420994 +SRR16298160,SRR16298160,Unassigned,20A,14341,14341,13508,94.1915,108.457,95.7295,11093,173.5,173.8,0.20,99.73,5,8,38,18527,0,11177,29704,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,4557.250055,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.63,,"[('Other', 0.9999999999986925)]",['B.1.243'],[1.],1.4061221334758691 +SRR16298174,SRR16298174,Unassigned,,148231,148231,134328,90.6207,0.360766,19.2355,0,62.3,127.6,99.45,0.03,0,98,98,29440,0,0,29440,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,"[('Other', 0.8936170212649831), ('A', 0.10638297872328144)]","['B' 'B.41' 'B.18' 'B.3' 'B.30' 'B.40' 'B.37' 'B.32' 'B.34' 'B.3.1' 'A.2' + 'B.60' 'B.39' 'B.35' 'A.5' 'B.43' 'A.24' 'A.26' 'A.25' 'A.2.3' 'A.11' + 'A.21' 'A.19' 'B.29' 'B.58' 'B.33' 'B.52' 'B.26' 'B.61' 'B.27' 'B.1.14' + 'B.20' 'B.15' 'B.19' 'B.1.1.161' 'B.6' 'B.47' 'B.23' 'B.57' 'B.12' 'B.28' + 'B.51' 'B.13' 'A' 'B.45' 'B.42' 'B.10' 'B.1.1.306' 'B.1.1.447' + 'B.1.1.175' 'B.1.1.172' 'B.1.1.376' 'B.1.1.203' 'B.1.1.500' 'B.1.1.121' + 'B.1.1.364' 'B.1.1.187' 'B.1.1.441' 'B.1.1.122' 'B.1.1.398' 'B.1.1.164' + 'B.1.1.137' 'B.1.1.134' 'B.1.1.59' 'B.1.1.367' 'B.1.1.118' 'B.1.1.148' + 'B.1.1.26' 'B.1.1.485' 'B.1.1.25' 'B.1.1.440' 'B.1.1.463' 'B.1.1.129' + 'B.1.1.57' 'B.1.1.10' 'B.1.1.378' 'B.1.350' 'B.1.267' 'B.1.108' 'B.1.39' + 'B.1.329' 'B.1.330' 'B.1.333' 'B.1.431' 'B.1.483' 'B.1.479' 'B.1.37' + 'B.1.13' 'B.1.274' 'B.1.277' 'B.1.210' 'B.1.214' 'B.1.231' 'B.1.408' + 'B.1.489' 'B.1.487' 'B.1.115' 'B.1.1.33' 'B.1.323' 'B.1.38' 'B.1.413' + 'B.1.360' 'B.1.321' 'B.1.166' 'B.1.319' 'B.1.513' 'B.1.520' 'B.1.510' + 'B.1.320' 'B.1.324' 'B.1.453' 'B.1.302' 'B.1.167' 'B.1.1.43' 'B.1.96' + 'B.1.1.180' 'B.1.205' 'B.1.543' 'B.1.220' 'B.1.178' 'B.1.213' 'B.1.6' + 'B.1.151' 'B.1.35' 'B.1.1.274' 'B.1.384' 'B.1.23' 'B.1.198' 'B.1.93' + 'B.1.69' 'B.1.206' 'B.1.137' 'B.1.194' 'B.1.70' 'B.1.199' 'B.1.545' + 'B.1.78' 'B.1.145' 'B.1.142' 'B.1.383' 'B.1.395' 'B.1.201' 'B.1.81' + 'B.1.8' 'B.1.215' 'B.1.76' 'B.1.67' 'B.1' 'B.1.222' 'B.1.379' 'B.1.182' + 'B.1.229' 'B.1.1.166' 'B.1.1.34' 'B.1.1.192' 'B.1.1.205' 'B.1.1.189' + 'B.1.1.71' 'B.1.1.142' 'B.1.1.95' 'B.1.401' 'B.1.399' 'B.1.558' 'B.1.238' + 'B.1.397' 'B.1.239' 'B.1.233' 'B.1.180' 'B.1.416' 'B.1.600' 'B.1.546' + 'B.1.393' 'B.1.153' 'B.1.551' 'B.1.382' 'B.1.1' 'B.1.415' 'B.1.181' + 'B.1.420' 'B.1.609' 'B.1.225' 'B.1.223' 'B.1.407' 'B.1.1.219' 'B.1.402' + 'B.1.1.13' 'B.1.1.194' 'B.1.1.38' 'B.1.1.208' 'B.1.1.165' 'B.59' 'N.4' + 'N.3' 'N.1' 'N.2' 'N.6' 'N.9' 'B.1.1.61' 'B.1.1.256' 'B.1.1.86' + 'B.1.1.308' 'B.1.1.239' 'B.1.1.89' 'B.1.533' 'B.1.1.354' 'B.1.1.125' + 'B.1.1.326' 'B.1.1.368' 'B.1.597' 'B.1.332' 'B.1.293' 'B.1.342' 'B.1.372' + 'B.1.12' 'B.1.356' 'B.1.340' 'B.1.40' 'B.1.492' 'B.1.554' 'B.1.276' + 'B.1.524' 'B.1.97' 'B.1.416.1' 'B.1.403' 'B.1.610' 'B.1.241' 'B.1.405' + 'B.1.1.432' 'L.2' 'B.1.1.236' 'B.1.1.209' 'B.1.1.243' 'B.1.1.482' + 'B.1.574' 'B.1.165' 'B.1.521' 'B.1.435' 'B.1.605' 'B.1.409' 'B.1.1.269' + 'B.1.1.190' 'B.1.1.227' 'B.1.532' 'B.1.1.207' 'D.4' 'B.1.1.453' 'AV.1' + 'B.1.1.44' 'B.1.445' 'B.1.375' 'B.1.1.351' 'B.1.1.182' 'D.5' 'B.1.314' + 'B.1.1.50' 'B.1.1.226' 'B.1.1.139' 'B.1.1.428' 'AE.1' 'AE.6' 'B.1.548' + 'B.1.576' 'B.1.346' 'N.8' 'B.1.426' 'B.1.448' 'B.1.596.1' 'B.1.578' + 'B.1.1.171' 'B.1.1.216' 'B.1.1.170' 'N.5' 'B.1.22' 'B.1.116' 'B.1.370' + 'B.1.336' 'B.1.1.356' 'B.1.1.107' 'B.1.1.307' 'B.1.1.300' 'B.1.1.514' + 'B.1.1.301' 'B.1.1.70' 'B.1.1.116' 'B.1.1.67' 'D.3' 'B.1.1.217' + 'B.1.1.141' 'B.1.1.280' 'B.1.1.506' 'B.1.560' 'B.1.1.46' 'B.1.1.487' + 'B.1.1.416' 'B.1.1.228' 'B.1.1.309' 'B.1.1.310' 'B.1.1.37' 'B.1.1.14' + 'B.1.236' 'B.1.530' 'B.1.1.297' 'B.1.1.404' 'B.1.1.8' 'B.1.1.423' + 'B.1.1.17' 'B.1.1.63' 'B.1.1.258' 'B.1.1.41' 'B.1.1.261' 'B.1.1.253' + 'B.1.1.82' 'B.1.1.270' 'B.1.1.249' 'B.1.1.421' 'B.1.1.133' 'B.1.1.115' + 'B.1.1.58' 'B.1.1.325' 'B.1.1.380' 'B.1.355' 'B.1.1.408' 'B.1.287' + 'B.1.515' 'B.1.298' 'B.1.366' 'B.1.117' 'B.1.304' 'B.1.452' 'B.1.451' + 'B.1.1.149' 'B.1.334' 'B.1.289' 'B.1.310' 'B.1.586' 'B.1.424' 'B.1.450' + 'B.1.301' 'B.1.265' 'B.1.1.374' 'B.1.1.365' 'B.1.1.362' 'B.1.1.285' + 'B.1.1.395' 'B.1.1.244' 'B.1.1.111' 'B.1.1.345' 'B.1.1.263' 'B.1.1.312' + 'B.1.1.114' 'B.1.1.113' 'B.1.1.162' 'B.1.1.360' 'B.1.1.210' 'B.1.1.48' + 'B.1.1.49' 'B.1.1.283' 'B.1.1.51' 'B.1.1.144' 'B.1.1.98' 'B.1.1.379' + 'B.1.235']","[0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 + 0.0106383 0.0106383 0.0106383 0.0106383 0.0106383 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873 + 0.0015873 0.0015873 0.0015873 0.0015873 0.0015873]",0.5000000000069557 +SRR16298175,SRR16298175,Unassigned,19A,142646,142646,132133,92.63,170.294,59.7331,6164,155.9,156.4,81.84,16.78,2,53,66,23682,0,6167,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,7499.560000,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.79,,"[('Other', 0.9936264669502398)]","['B.1.390' 'B.1.1.261' 'B.1.165' 'B.1.110' 'B.1.323' 'B.1.413' 'B.1.513' + 'B.1.510' 'B.1.572' 'B.1.453' 'B.1.268' 'B.1.489' 'B.1.350' 'B.1.161' + 'B.1.473' 'B.1.287' 'B.1.428' 'B.1.117' 'B.1.314' 'B.1.199' 'B.1.6' + 'B.1.143' 'B.1.379' 'B.1.182' 'B.1.180' 'B.1.223' 'B.1.225' 'B.1.145' + 'B.1.201' 'B.1.609' 'B.1.96' 'B.1.8' 'B.1.134' 'B.1.215' 'B.1.67' + 'B.1.210' 'B.1' 'B.1.378' 'B.1.402' 'B.1.428.1' 'B.1.346' 'B.1.110.1' + 'B.55' 'B.1.1.37' 'B.1.1.283' 'B.1.310' 'B.1.39' 'B.1.1.175' 'B.1.1.384' + 'B.1.1.351' 'B.1.415']","[0.041841 0.03312847 0.02816748 0.02816748 0.02816748 0.02816748 + 0.02816748 0.02816748 0.02816748 0.02816748 0.02816748 0.02816748 + 0.02816748 0.02816748 0.02816748 0.02816748 0.02816748 0.02816748 + 0.02816748 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 + 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 + 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 0.02105164 + 0.02105164 0.02105164 0.00854701 0.00517627 0.00517356 0.0046729 + 0.00264317 0.00257732 0.00252525 0.0020202 0.00170358 0.00140647 + 0.00114943 0.0011274 0.00110619]",2.107131994924186 +SRR13433883,SRR13433883,B.1.258.23,20A,106223,106223,103545,97.4789,892.565,99.8662,28371,275.6,275.6,0.01,99.96,25,0,3,1515,0,28378,29893,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,96.812500,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.258.23(1/1),"[('Other', 0.9999999999999977)]",['B.1.258.23'],[1.],0.4943510022446659 +SRR12192434,SRR12192434,B.1.336,20C,22164,22164,18803,84.8358,149.7,99.9599,25339,189.6,190.9,3.36,96.25,4,0,0,4352,0,25539,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,225.222277,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.15,Usher placements: B.1.336(4/4),"[('Other', 0.9999999999914736)]",['B.1.336' 'B.1.333'],[0.994253 0.005747],1.449546776376567 +SRR13687078,SRR13687078,B.1.1.362,20B,33826,33826,31549,93.2685,296.485,99.5118,26782,155.2,155.6,0.03,99.89,9,0,1,3068,0,26828,29896,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,105.100466,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.11,Usher placements: B.1.1.362(2/2),"[('Other', 0.999999999999946)]",['B.1.1.362'],[1.],1.2781016034105142 +SRR13195052,SRR13195052,B.1.1.139,20B,416419,416419,387426,93.0375,3289.94,99.9732,29621,195.8,196.2,0.00,99.72,10,0,0,269,0,29633,29902,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.139(1/1),"[('Other', 0.9981757570085352)]",['B.1.1.139'],[0.99817576],0.9304229541818549 +SRR13574337,SRR13574337,B.1.375,20C,1245538,1245538,1053080,84.5482,1554.99,99.9933,29827,284.4,285.4,20.22,23.76,15,0,0,71,0,29826,29897,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9974950820017968)]",['B.1.375' 'B.1.306'],[0.996375 0.00112008],1.5318447613638648 +SRR12733606,SRR12733606,B.1.390,20A,776002,776002,653607,84.2275,636.733,99.9799,29273,203.4,204.3,0.79,15.70,7,0,0,614,1,29282,29897,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,2.352483,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.390(1/1),"[('Other', 0.9985894800002555)]",['B.1.390' 'B.1.557'],[0.997249 0.00134048],1.3111670291400404 +ERR5691945,ERR5691945,B.1.351,"20H (Beta, V2)",1735046,1735046,1723717,99.347,20605.5,99.9766,29569,390.9,391.2,0,99.89,23,0,1,7666,0,22215,29881,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,744.279232,bad,,,Beta (B.1.351-like),0.79,0.0,scorpio call: Alt alleles 11; Ref alleles 0; Amb alleles 1; Oth alleles 2,SCORPIO_v0.1.4,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.27,scorpio called lineage B.1.351,"[('Beta', 0.9987345108397899)]",['B.1.351'],[0.99873451],5.557750812666864 +SRR12530461,SRR12530461,B.1.1.431,20B,584532,584532,575787,98.5039,4994.48,99.4649,27617,239.2,239.7,0.00,99.85,16,0,1,2247,0,27617,29864,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,52.000123,mediocre,0.5,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.09,Usher placements: B.1.1(1/2) B.1.1.431(1/2),"[('Other', 0.9703939810747845)]","['B.1.1.213' 'B.1.1.402' 'B.1.1.174' 'B.1.1.274' 'B.1.1.192' 'B.1.1.283' + 'B.1.1.89' 'B.1.1.194' 'B.1.1.43' 'B.1.533']","[0.91415241 0.02718763 0.00891243 0.00854701 0.00294768 0.00242256 + 0.00201342 0.00182306 0.00131349 0.0010743 ]",3.577584903254084 +ERR5181310,ERR5181310,B.1.525,21D (Eta),912571,912571,909776,99.6937,10999.1,99.6154,29734,391.7,391.9,0,99.96,35,0,0,67,0,29732,29799,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,Eta (B.1.525-like),1.0,0.0,scorpio call: Alt alleles 16; Ref alleles 0; Amb alleles 0; Oth alleles 0,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Eta', 0.9995440000019115)]",['B.1.525'],[0.999544],6.0230211922291605 +SRR13129709,SRR13129709,D.3,20B,568486,568486,555853,97.7778,4611.04,99.8328,29547,215.9,216.2,0,99.84,14,0,0,304,0,29549,29853,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000219,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: D.3(1/1),"[('Other', 0.9957973393754935)]",['D.3'],[0.99579734],0.7540556101956113 +ERR5743043,ERR5743043,B.1.617.2,21J (Delta),1890053,1890053,1883051,99.6295,22727.6,99.99,29639,391.8,391.9,0,99.95,26,0,0,9105,0,20789,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1063.484568,bad,,,Delta (B.1.617.2-like),0.69,0.0,scorpio call: Alt alleles 9; Ref alleles 0; Amb alleles 4; Oth alleles 0,SCORPIO_v0.1.4,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.32,scorpio called lineage B.1.617.2,"[('Delta', 0.9894888314014936)]",['AY.1' 'AY.46.1'],[0.98787827 0.00161056],2.342570902566065 +SRR13486908,SRR13486908,B.1.385,20A,3297513,3297513,3038569,92.1473,14336,100,29869,256.6,257.5,0.27,76.24,17,0,0,34,0,29869,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,6.250000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9984620435063583)]",['B.1.385'],[0.99846204],3.620952693076005 +SRR13526755,SRR13526755,B.1.1.418,20B,1068040,1068040,968596,90.6891,8293.36,99.8997,29782,179.7,179.9,0.00,99.95,18,0,0,91,0,29782,29873,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.418(1/1),"[('Other', 0.9987200000023091)]",['B.1.1.418'],[0.99872],0.6667989871522338 +SRR12774785,SRR12774785,Unassigned,20C,29696,29696,27583,92.8846,250.013,98.8663,24539,150.6,150.9,0.00,99.91,7,0,4,5293,1,24597,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,342.975981,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.19,,"[('Other', 1.0000000000000215)]",['B.1.287' 'B.1.319' 'B.1.324'],[0.993243 0.00505051 0.00170649],0.4394224647772782 +SRR16298167,SRR16298167,Unassigned,,1330,1330,96,7.21805,0.0167207,1.21393,0,363.0,363.0,0,1.04,0,98,98,363,0,0,363,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,[],[],[],6.666422494759199e-12 +SRR16298171,SRR16298171,B.1,20C,356628,356628,326814,91.64,2481.3,94.0006,25675,155.1,155.3,0.02,99.39,33,2,4,4177,2,25700,29879,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,864.528604,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.15,Usher placements: B.1(2/2),"[('Other', 0.9782430294139861)]",['B.1.344' 'B.1.355' 'B.1.360' 'B.1.167' 'B.1.453'],[0.97280162 0.00178253 0.0013541 0.00130378 0.001001 ],8.903653341053312 +SRR12901576,SRR12901576,B.1,20C,363267,363267,354907,97.6987,3151.37,99.3914,28880,254.8,254.7,0.05,99.91,7,0,0,1012,0,28888,29900,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,6.953964,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: B.1(1/1),"[('Other', 0.9894937379980409)]",['B.1.515' 'B.1.372' 'B.1.306' 'B.1.298'],[0.98271264 0.00309598 0.00262467 0.00106045],1.605234296209766 +SRR13690003,SRR13690003,B.1,20G,753605,753605,706369,93.732,6275.35,99.9632,29597,198.1,198.3,0.00,99.93,18,0,0,296,7,29590,29893,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,53.340278,mediocre,0.5,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1(1/2) B.1.2(1/2),"[('Other', 0.8977417300595328), ('Epsilon', 0.09303430966351274)]",['B.1.2' 'B.1.550' 'B.1.427'],[0.67683973 0.220902 0.09303431],5.808671478208372 +SRR16298173,SRR16298173,Unassigned,19A,138431,138431,125512,90.6676,993.646,93.4455,25104,166.8,167.0,0.00,99.51,0,1,1,4733,1,25104,29838,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,270.567750,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.17,,"[('Other', 0.9982667019940928)]",['B' 'B.10' 'B.57' 'B.11'],[0.99311365 0.00300752 0.0010929 0.00105263],0.4794874213620607 +SRR11915959,SRR11915959,B.35,19A,553601,553601,542581,98.0094,4599.47,99.8529,28759,235.3,235.7,0.00,99.78,8,0,1,1105,5,28756,29866,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,33.889232,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.05,Usher placements: B.35(1/1),"[('Other', 0.9868019551687629)]",['B.35'],[0.98680196],8.133502169006327 +SRR12763543,SRR12763543,B.1.1.463,20B,1236202,1236202,1093951,88.4929,9470.23,99.1941,27551,187.4,187.5,0.00,99.92,7,0,5,2340,0,27555,29895,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,57.086420,mediocre,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.09,Usher placements: B.1.1.463(1/1),"[('Other', 0.9808708089987518)]",['B.1.1.463' 'B.1.1.71' 'B.1.1.231'],[0.97809008 0.00144988 0.00133085],0.6383475004073575 +SRR16298165,SRR16298165,Unassigned,19B,533855,533855,499859,93.632,3900.34,43.3134,10764,158.6,158.8,0,99.94,6,48,46,16112,0,10770,26882,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,3429.620631,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.64,,"[('Other', 0.9903667149857094)]",['B.1.1.348'],[0.99036671],2.8796572563497858 +SRR14241199,SRR14241199,B.1.526,21F (Iota),222498,222498,200666,90.1878,2842.08,99.9164,28449,385.7,385.8,0.04,98.96,25,0,0,1423,0,28449,29872,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,28.410549,good,0.0,,Iota (B.1.526-like),0.83,0.17,scorpio call: Alt alleles 19; Ref alleles 4; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.06,Usher placements: B.1.526(4/4),"[('Iota', 0.9996070000009828)]",['B.1.526'],[0.999607],3.8198925520490183 +SRR11494584,SRR11494584,B.4.5,19A,604651,604651,598174,98.9288,5163.91,99.7425,29782,241.0,241.3,0,99.82,5,0,0,44,0,29782,29826,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9970961030090059)]",['B.4.5'],[0.9970961],1.5129100209719262 +SRR13606410,SRR13606410,P.2,20B,92107,92107,87333,94.8169,1219.75,99.7358,29805,381.5,383.0,0.08,99.86,20,0,0,19,0,29805,29824,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,Zeta (P.2-like),0.86,0.14,scorpio call: Alt alleles 6; Ref alleles 1; Amb alleles 0; Oth alleles 0,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Zeta', 0.9987559999999484)]",['P.2'],[0.998756],2.281432791659655 +SRR13690340,SRR13690340,B.1.232,20A,333889,333889,301041,90.162,2691.74,100,29576,200.3,200.4,0,99.95,18,0,0,327,1,29575,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,7.260000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.232(1/1),"[('Other', 0.9943996580042727)]",['B.1.232' 'B.1.2' 'B.1.383' 'B.1.382'],[0.720549 0.27023337 0.00258953 0.00102775],2.5862526843447418 +ERR5556343,ERR5556343,P.1,"20J (Gamma, V3)",216817,216817,215689,99.4797,2590.21,99.6656,27915,385.5,385.7,0.00,99.81,32,0,0,1838,0,27964,29802,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,32.447791,mediocre,0.25,,Gamma (P.1-like),0.88,0.0,scorpio call: Alt alleles 14; Ref alleles 0; Amb alleles 0; Oth alleles 2,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.08,Usher placements: P.1(6/8) P.1.12(1/8) P.1.3(1/8),"[('Gamma', 0.9997100609955514)]",['P.1.12'],[0.99971006],1.5196978493856381 +SRR13195265,SRR13195265,B.1.1.205,20B,1946500,1946500,1035164,53.1808,7529.44,99.5954,29567,134.7,135.9,0.00,99.69,9,0,0,194,0,29588,29782,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.205(1/1),"[('Other', 0.9879382599984355)]",['B.1.1.205' 'B.1.1.197' 'B.1.1.92' 'B.1.1.71'],[0.982222 0.00250878 0.00175029 0.00145719],0.8927006760053333 +SRR12833927,SRR12833927,B.1.1.514,20B,1287220,1287220,1210340,94.0274,10624,98.7493,29470,190.6,190.8,0.00,99.90,8,0,1,88,0,29473,29561,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.1.514(1/1),"[('Other', 0.9956199999981679)]",['B.1.1.514'],[0.99562],0.5887335846335993 +ERR5771988,ERR5771988,B.1.617.1,21B (Kappa),1111192,1111192,1107889,99.7028,13336.6,99.7826,29512,391.6,391.7,0,99.96,28,1,1,2618,0,27253,29871,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,73.705405,mediocre,0.0,,B.1.617.1-like,0.91,0.0,scorpio call: Alt alleles 10; Ref alleles 0; Amb alleles 1; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.1,Usher placements: B.1.617.1(1/1),"[('Kappa', 0.9997299999981215)]",['B.1.617.1'],[0.99973],1.1430132476192507 +SRR12833718,SRR12833718,B.1.1.174,20B,651160,651160,606671,93.1677,5205.77,97.211,27112,185.8,186.2,0,99.88,14,0,3,2433,8,27120,29561,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,127.972500,bad,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.1,Usher placements: B.1.1.174(1/1),"[('Other', 0.9986144471747955)]",['B.1.1.174'],[0.99861445],2.5198505644603904 +SRR16298170,SRR16298170,Unassigned,19B,606680,606680,554256,91.3589,4298.65,89.0279,24881,163.2,163.5,0.20,99.70,3,2,2,4931,0,24881,29812,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,294.186022,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.18,,"[('A', 0.9924741169995949), ('Other', 0.005412719992833232)]",['A' 'B.23'],[0.99247412 0.00541272],1.5447446235311508 +SRR16298164,SRR16298164,Unassigned,,37159,37159,36931,99.3864,0.0650102,4.07651,0,166.6,176.8,97.48,0.02,0,98,98,29849,0,0,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,,,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,failed to map,,,,, +SRR13603869,SRR13603869,B.1.427,21C (Epsilon),35473,35473,33496,94.4267,316.52,98.3982,24179,156.6,156.8,0.01,99.92,14,1,5,5657,0,24192,29849,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,393.654993,bad,,,Epsilon (B.1.427-like),0.62,0.0,scorpio call: Alt alleles 8; Ref alleles 0; Amb alleles 5; Oth alleles 0,SCORPIO_v0.1.4,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.2,scorpio called lineage B.1.427,"[('Epsilon', 0.9999999999999837)]",['B.1.427'],[1.],2.1333243393292336 +SRR11577968,SRR11577968,B.1.320,20C,436687,436687,433315,99.2278,3908.91,99.7693,29624,254.3,254.5,0,99.90,7,0,0,207,0,29627,29834,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.02,Usher placements: B.1.320(1/1),"[('Other', 0.992723891019766)]",['B.1.320'],[0.99272389],0.6609690453040331 +SRR13195337,SRR13195337,B.1.309,20C,2277602,2277602,1320912,57.9957,9910.91,99.6489,29782,143.4,144.3,0,99.79,14,0,0,16,0,29782,29798,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9903760000002543)]",['B.1.309'],[0.990376],0.8957858223202387 +SRR13422799,SRR13422799,B.1.429,21C (Epsilon),76082,76082,72210,94.9108,954.433,99.8462,29253,381.3,382.2,0.07,99.79,31,0,1,638,0,29253,29891,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,5.907411,good,0.0,,Epsilon (B.1.429-like),1.0,0.0,scorpio call: Alt alleles 14; Ref alleles 0; Amb alleles 0; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.03,Usher placements: B.1.429(1/1),"[('Epsilon', 0.9988139999990485)]",['B.1.429'],[0.998814],9.506507932009322 +SRR16298158,SRR16298158,Unassigned,20A,300310,300310,268801,89.5078,755.487,40.4541,5484,143.4,143.9,61.49,37.36,8,68,71,24379,1,5483,29863,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,8012.149139,bad,,,,,,,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.82,,"[('Other', 0.9975843876897825)]",['B.1.177.33' 'B.1.601'],[0.99657633 0.00100806],2.2757488290680765 +ERR5181360,ERR5181360,B.1.525,21D (Eta),1500457,1500457,1492260,99.4537,17923,99.8361,29746,398.8,398.5,0,99.96,32,0,0,2195,0,27633,29828,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,49.259602,mediocre,0.0,,Eta (B.1.525-like),0.94,0.0,scorpio call: Alt alleles 15; Ref alleles 0; Amb alleles 1; Oth alleles 0,PUSHER-v1.2.133,4.0.3,0.3.16,v0.1.4,False,pass,Ambiguous_content:0.09,Usher placements: B.1.525(8/8),"[('Eta', 0.9994976652554511)]",['B.1.525'],[0.99949767],6.485208364316353 +ERR5749609,ERR5749609,B.1.617.2,21J (Delta),2323723,2323723,2315943,99.6652,27728,99.9833,29729,391.3,391.4,0,99.96,26,0,0,10326,1,19567,29894,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,1379.884444,bad,,,Delta (B.1.617.2-like),0.69,0.0,scorpio call: Alt alleles 9; Ref alleles 0; Amb alleles 4; Oth alleles 0,SCORPIO_v0.1.4,4.0.3,0.3.16,v0.1.4,False,fail,Ambiguous_content:0.36,scorpio called lineage B.1.617.2,"[('Delta', 0.990006062828753)]",['AY.46' 'AY.46.1'],[0.98859024 0.00141582],2.50549594192071 +SRR12661075,SRR12661075,B.1.452,20C,3399069,3399069,3018507,88.8039,26574.4,100,29815,187.6,187.7,0,99.94,8,0,0,88,0,29815,29903,seqyclean : Version: 1.10.09 (2018-10-16),bwa : Version: 0.7.17-r1188,ivar : iVar version 1.3.1,iVar version 1.3.1,0.000000,good,0.0,,,,,,PANGO-v1.2.133,4.0.3,0.3.16,v0.1.4,True,pass,Ambiguous_content:0.02,Assigned from designation hash.,"[('Other', 0.9865538134609476)]",['B.1.452'],[0.98655381],0.5219594381346055 diff --git a/images/multiqc_fastqc.png b/images/multiqc_fastqc.png new file mode 100755 index 0000000..ba146ef Binary files /dev/null and b/images/multiqc_fastqc.png differ diff --git a/images/multiqc_ivar.png b/images/multiqc_ivar.png new file mode 100755 index 0000000..1047e2b Binary files /dev/null and b/images/multiqc_ivar.png differ diff --git a/images/multiqc_kraken2.png b/images/multiqc_kraken2.png new file mode 100755 index 0000000..583e432 Binary files /dev/null and b/images/multiqc_kraken2.png differ