diff --git a/.github/workflows/ci.yaml b/.github/workflows/ci.yaml index 66e8334..d447632 100644 --- a/.github/workflows/ci.yaml +++ b/.github/workflows/ci.yaml @@ -1,8 +1,8 @@ -name: Tests +name: CI on: push: branches: - - master + - main paths-ignore: - 'docs/**' - '*.md' @@ -14,7 +14,7 @@ on: - '*.rst' jobs: tests: - name: Lint with R and Python ${{ matrix.python }} + name: Test with Python ${{ matrix.python }} runs-on: ${{ matrix.os }} strategy: fail-fast: false @@ -30,6 +30,11 @@ jobs: - uses: actions/setup-python@v5 with: python-version: ${{ matrix.python }} + - name: Install apt packages + run: | + sudo apt-get update \ + && sudo apt-get install -y samtools texlive-latex-extra texlive-latex-recommended \ + && sudo apt-get remove -y fonts-urw-base35 libgs9 libgs9-common libjbig2dec0 poppler-data - name: Cache conda uses: actions/cache@v4 env: @@ -59,3 +64,6 @@ jobs: - name: Lint R script run: | Rscript -e 'library(lintr); options(lintr.error_on_lint=TRUE); lint_dir(".", linters=linters_with_tags("correctness"))' + - name: Test script outputs + run: | + cd test && make test diff --git a/Makefile b/Makefile index 30372da..c0d4e4a 100644 --- a/Makefile +++ b/Makefile @@ -2,31 +2,43 @@ # Nextflow workflow output directory wf_out_dir := workflow-outputs/output +snapshot_dir := test/build-snapshot -all: laava laava_dev +# Form Bio workflow deployment +formbio_org := form-bio-solutions +formbio_project := aav-qc-workshop +# Avoid uploading the local test dir; it's > the upload size limit +tmp_stash_dir := /tmp/laava-deploy-test -.PHONY: clean laava laava_dev sc ss diffcheck-sc diffcheck-ss +all: laava laava_dev sc ss min folder + +.PHONY: clean laava laava_dev sc ss min folder diffcheck-sc diffcheck-ss formbio clean: - rm -fv .nextflow.log* - rm -fv test/build/* - rm -rf workflow-outputs/* + rm -f .nextflow.log* + rm -fr .nextflow/* + rm -fr workflow-outputs/* + laava laava_dev: %: %.dockerfile laava.conda_env.yml docker build -t ghcr.io/formbio/$@:latest -f $< . -sc: params-local-sc-no-ff.json +sc ss min folder: %: params-local-%.json nextflow run -profile local main.nf -params-file $< -ss: params-local-ss-with-ff.json - nextflow run -profile local main.nf -params-file $< -min: params-local-no-file-sc.json - nextflow run -profile local main.nf -params-file $< +diffcheck-sc: $(wf_out_dir)/sc.subsample005.per_read.tsv + diff $(snapshot_dir)/sc.per_read.tsv $< && echo "OK" + +diffcheck-ss: $(wf_out_dir)/ss.subsample005.per_read.tsv $(wf_out_dir)/ss.subsample005.flipflop.tsv + #diff $(snapshot_dir)/ss.per_read.tsv $< && echo "OK" + diff $(snapshot_dir)/ss.flipflop.tsv $(lastword $^) && echo "OK" -diffcheck-sc: $(wf_out_dir)/sc.subsample005.bam.per_read.tsv - diff test/build-snapshot/sc.per_read.tsv $< && echo "OK" -diffcheck-ss: $(wf_out_dir)/ss.subsample005.bam.per_read.tsv $(wf_out_dir)/ss.subsample005.bam.flipflop.tsv - diff test/build-snapshot/ss.per_read.tsv $< && echo "OK" - diff test/build-snapshot/ss.flipflop.tsv $(lastword $^) && echo "OK" +formbio: clean + mv test/ "$(tmp_stash_dir)" + formbio workflow upload \ + --org "$(formbio_org)" --project "$(formbio_project)" \ + --env prod --visibility PROJECT \ + --version dev --repo . --workflow laava + mv "$(tmp_stash_dir)" test diff --git a/README.md b/README.md index 82678c2..a5fb62f 100644 --- a/README.md +++ b/README.md @@ -64,8 +64,8 @@ There are several ways to satisfy the script dependencies locally. ### Option 1: Development docker image (`laava_dev` container image) The `laava_dev.dockerfile` in this repo installs the scripts' dependencies, but not the -scripts themselves, into a Docker container image that you can then use to run the -local copies of the scripts. +scripts themselves, into a Docker container image that you can then use to run the local +copies of the scripts. To build the container image with the name `laava_dev` (you can use another name if you prefer): @@ -136,17 +136,39 @@ R packages: ## Testing +### Automated local tests + The `test/` subdirectory in this repo contains small example input files and a Makefile to run the scripts to reanalyze them and produce example HTML and PDF reports. -Once you've completed installation (above), activate your conda environment or Docker container and change to the test directory: +Once you've completed installation (above), activate your conda environment or Docker +container and change to the test directory: ``` cd test ``` -To generate the HTML and PDF reports from the test dataset included in the repo (this takes about 1-2 minutes): +To generate the HTML and PDF reports from the test dataset included in the repo, use any +of these commands: -``` -make -``` +* `make sc` -- run the example self-complementary AAV (scAAV) sample. This takes about 1-2 minutes. +* `make ss` -- run the example single-stranded AAV (ssAAV) sample. This takes about 2-3 minutes, including an additional flip/flop analysis step. +* `make all` -- run both example AAV samples. +* `make test` -- run both samples and check the results quantitatively. + + +### Example Nextflow jobs + +The top level of this repo includes several JSON files with Nextflow parameter +configurations (`params-*.json`). They use the same inputs as the automated test suite +(above), plus the `laava` Docker image and a local installation of `nextflow` (which you +can install any way you like, e.g. conda or brew). + +You can run them directly with Nextflow as usual, or use the Makefile at the top level +of the repo to launch them: + +* `make sc` or `make ss` -- run the example self-complementary AAV (scAAV) or + single-stranded AAV (ssAAV) sample, as above. +* `make min` -- run the scAAV sample with the minimum number of required parameters, + exercising the default behavior including guessing the construct vector type (sc/ss). +* `make folder` -- run both samples via folder input. diff --git a/laava.conda_env.yml b/laava.conda_env.yml index e06d3ce..522246a 100644 --- a/laava.conda_env.yml +++ b/laava.conda_env.yml @@ -7,8 +7,10 @@ dependencies: - python>=3.7.6 - r-base>=3.6.0 - biopython + - pandas - parasail-python>=1.3.4 - pysam + - pytest - r-flextable - r-lintr - r-rmarkdown diff --git a/laava.dockerfile b/laava.dockerfile index 0c6ab6f..ba29a35 100644 --- a/laava.dockerfile +++ b/laava.dockerfile @@ -1,5 +1,5 @@ # Interactive environment with scripts and extra dependencies -FROM --platform=linux/amd64 continuumio/miniconda3:24.4.0-0 +FROM --platform=linux/amd64 continuumio/miniconda3:24.7.1-0 LABEL org.opencontainers.image.source https://github.com/formbio/AAV RUN apt-get update \ @@ -21,15 +21,15 @@ RUN rm -rf /var/lib/apt/lists/* # Install directly into 'base' conda environment COPY laava.conda_env.yml ./conda_env.yml -RUN conda install -y -n base python=3.10 RUN conda env update -v -n base -f conda_env.yml # Executable scripts RUN mkdir -p /opt/laava RUN chmod 777 /opt/laava/ COPY src/* /opt/laava/ -RUN chmod +x /opt/laava/*.py /opt/laava/*.R +RUN chmod +x /opt/laava/*.py /opt/laava/*.R /opt/laava/*.sh ENV PATH "/opt/laava:$PATH" +ENV PYTHONPATH "/opt/laava:$PYTHONPATH" WORKDIR /data/ diff --git a/laava_dev.conda_env.yml b/laava_dev.conda_env.yml index acaafe7..2ebc82b 100644 --- a/laava_dev.conda_env.yml +++ b/laava_dev.conda_env.yml @@ -9,6 +9,7 @@ dependencies: - biopython - graphviz - nextflow + - pandas - parasail-python>=1.3.4 - pysam - pytest @@ -17,3 +18,4 @@ dependencies: - r-rmarkdown - r-tidyverse - ruff + - shellcheck diff --git a/laava_dev.dockerfile b/laava_dev.dockerfile index 0dfe6a7..c6d3db4 100644 --- a/laava_dev.dockerfile +++ b/laava_dev.dockerfile @@ -1,5 +1,5 @@ # Development environment for running the scripts, no scripts, extra dependencies -FROM --platform=linux/amd64 continuumio/miniconda3:24.4.0-0 +FROM --platform=linux/amd64 continuumio/miniconda3:24.7.1-0 # Set the container's timezone to match this local machine RUN ln -snf /usr/share/zoneinfo/$CONTAINER_TIMEZONE /etc/localtime && echo $CONTAINER_TIMEZONE > /etc/timezone @@ -27,7 +27,6 @@ RUN apt-get update \ # Install directly into 'base' conda environment COPY laava_dev.conda_env.yml ./conda_env.yml -RUN conda install -y -n base python=3.10 RUN conda env update -v -n base -f conda_env.yml WORKDIR /data/ diff --git a/main.nf b/main.nf index 4252dc8..5454351 100644 --- a/main.nf +++ b/main.nf @@ -1,67 +1,54 @@ #!/usr/bin/env nextflow nextflow.enable.dsl=2 -include { map_reads; make_report } from './modules/local/laava' +include { match_metadata_to_files; map_reads; make_report } from './modules/local/laava' NO_FILE = file("$projectDir/bin/NO_FILE") NO_FILE2 = file("$projectDir/bin/NO_FILE2") // Unpack the input sample(s) and metadata -def prepareInput( +def prepare_input( seq_reads_file, seq_reads_folder, sample_unique_id, sample_display_name, sample_in_metadata ) { - // Known file extensions def SAMPLE_FILE_GLOB = "*.{bam,fastq,fastq.gz,fq,fq.gz}" def EXTENSION_REGEX = /\.(bam|fastq|fastq\.gz|fq|fq\.gz)$/ if (seq_reads_folder) { // Multi-sample mode - def sampleFiles = file("${params.seq_reads_folder}/${SAMPLE_FILE_GLOB}") - - if (params.sample_in_metadata) { - // Metadata provided - use it to match files - def csvData = channel - .fromPath(params.sample_in_metadata) - .splitCsv(header: true, sep='\t', strip=true) - .map { row -> [row.sample_unique_id, row.sample_display_name] } - .toList() - .val - def matchedSamples = csvData.collect { sampleId, sampleName -> - def matchingFiles = sampleFiles.findAll { it.name.contains(sampleId) } - if (matchingFiles.size() != 1) { - error "Error: sample_unique_id '${sampleId}' matches ${matchingFiles.size()} files. Values must be unique." - } - [sampleId, sampleName, matchingFiles[0]] - } - // Check if all files were matched - def unmatchedFiles = sampleFiles - matchedSamples.collect { it[2] } - if (unmatchedFiles) { - error "Error: The following files were not matched to any sample_unique_id: ${unmatchedFiles.join(', ')}" - } - return channel.fromList(matchedSamples) + if (sample_in_metadata) { + // TSV provided - load it in a separate process + return match_metadata_to_files(file(sample_in_metadata), file(seq_reads_folder)) + .splitCsv(sep: '\t') + .map { row -> [row[0], row[1], file("${seq_reads_folder}/" + row[2])] } } else { - // No metadata provided - generate sampleId and sampleName from filenames - return channel.fromList(sampleFiles.collect { sampleFile -> - def stem = sampleFile.baseName.replaceFirst(EXTENSION_REGEX, '') - [stem, stem, sampleFile] + // No TSV provided - generate sample_id and sample_name from filenames + //def found_files = file("${sample_folder}/*.{bam,fastq,fastq.gz,fq,fq.gz}") + def found_files = file("${seq_reads_folder}/${SAMPLE_FILE_GLOB}") + return channel.fromList(found_files.collect { seqfile -> + def stem = seqfile.baseName.replaceFirst(EXTENSION_REGEX, '') + [stem, stem, seqfile] }) + } - } else if (params.seq_reads_file) { + } else if (seq_reads_file) { // Single-sample mode - def sampleFile = file(params.seq_reads_file) - if (!sampleFile.name.matches(/.*${EXTENSION_REGEX}/)) { - error "Error: The provided sample file '${sampleFile.name}' does not have a supported extension (${SAMPLE_FILE_GLOB})" + def seq_file = file(seq_reads_file) + if (!seq_file.exists()) { + error "Error: The provided sample file '${seq_reads_file}' does not exist." + } + if (!seq_file.name.matches(/.*${EXTENSION_REGEX}/)) { + error "Error: The provided sample file '${seq_file.name}' does not have a supported extension (bam, fastq, fastq.gz, fq, fq.gz)" } - def stem = sampleFile.baseName.replaceFirst(EXTENSION_REGEX, '') - def sampleId = params.sample_unique_id ?: stem - def sampleName = params.sample_display_name ?: params.sample_unique_id ?: stem - return channel.of([sampleId, sampleName, sampleFile]) + def stem = seq_file.baseName.replaceFirst(EXTENSION_REGEX, '') + def sample_id = sample_unique_id ?: stem + def sample_name = sample_display_name ?: sample_unique_id ?: stem + return channel.of([sample_id, sample_name, seq_file]) } else { - error "Invalid input parameters. Provide either a sample folder path or a single sample file." + error "Invalid input parameters. Provide either a sample folder, a TSV file with sample folder, or a single sample file." } } @@ -91,7 +78,7 @@ workflow laava { main: // Get a tuple of (ID, name, file) each given sample file and metadata - sample_channel = prepareInput( + sample_channel = prepare_input( seq_reads_file, seq_reads_folder, sample_unique_id, sample_display_name, sample_in_metadata ) @@ -120,20 +107,15 @@ workflow laava { emit: mapped_sam = map_reads.out.mapped_sam mapped_bam = map_reads.out.mapped_bam + metadata_out_tsv = make_report.out.metadata_tsv + alignments_tsv = make_report.out.alignments_tsv per_read_tsv = make_report.out.per_read_tsv - summary_tsv = make_report.out.summary_tsv - nonmatch_stat_tsvgz = make_report.out.nonmatch_stat_tsvgz + nonmatch_tsv = make_report.out.nonmatch_tsv tagged_bam = make_report.out.tagged_bam subtype_bams = make_report.out.subtype_bams subtype_bais = make_report.out.subtype_bais - flipflop_assignments_tsv = make_report.out.flipflop_assignments_tsv flipflop_bams = make_report.out.flipflop_bams - alignments_tsv = make_report.out.alignments_tsv - readsummary_tsv = make_report.out.readsummary_tsv - sequence_error_tsv = make_report.out.sequence_error_tsv flipflop_tsv = make_report.out.flipflop_tsv - rdata = make_report.out.rdata - metadata_out_tsv = make_report.out.metadata_tsv } diff --git a/modules/local/laava.nf b/modules/local/laava.nf index d226476..93ba52c 100644 --- a/modules/local/laava.nf +++ b/modules/local/laava.nf @@ -1,3 +1,19 @@ +process match_metadata_to_files { + input: + path sample_in_metadata + path sample_folder + + output: + path("metadata_with_paths.tsv") + + script: + """ + match_metadata_to_files.py ${sample_in_metadata} ${sample_folder} \\ + > metadata_with_paths.tsv + """ +} + + process map_reads() { publishDir "$params.output", mode: "copy" @@ -60,23 +76,17 @@ process make_report() { path(flipflop_fa) output: - // summarize alignment - path("${sample_id}.per_read.tsv"), emit: per_read_tsv - path("${sample_id}.summary.tsv"), emit: summary_tsv - path("${sample_id}.nonmatch_stat.tsv.gz"), emit: nonmatch_stat_tsvgz + // summary tables + path("${sample_id}.metadata.tsv"), emit: metadata_tsv + path("${sample_id}.alignments.tsv.gz"), emit: alignments_tsv + path("${sample_id}.per_read.tsv.gz"), emit: per_read_tsv + path("${sample_id}.nonmatch.tsv.gz"), emit: nonmatch_tsv + path("${sample_id}.flipflop.tsv.gz"), emit: flipflop_tsv, optional: true + // intermediate data path("${sample_id}.tagged.bam"), emit: tagged_bam path("${sample_id}.*.tagged.sorted.bam"), emit: subtype_bams path("${sample_id}.*.tagged.sorted.bam.bai"), emit: subtype_bais - // flip-flop - path("${sample_id}.flipflop_assignments.tsv"), emit: flipflop_assignments_tsv, optional: true - path("${sample_id}.*-flipflop.bam"), emit: flipflop_bams, optional: true - // intermediate data - path("${sample_id}.metadata.tsv"), emit: metadata_tsv - path("${sample_id}.alignments.tsv"), emit: alignments_tsv - path("${sample_id}.readsummary.tsv"), emit: readsummary_tsv - path("${sample_id}.sequence-error.tsv"), emit: sequence_error_tsv - path("${sample_id}.flipflop.tsv"), emit: flipflop_tsv, optional: true - path("${sample_id}.Rdata"), emit: rdata, optional: true + path("${sample_id}.flipflop-*.bam"), emit: flipflop_bams, optional: true // report path("${sample_id}_AAV_report.html"), emit: aav_report_html path("${sample_id}_AAV_report.pdf"), emit: aav_report_pdf diff --git a/nextflow.config b/nextflow.config index 7b8b916..61a52bb 100644 --- a/nextflow.config +++ b/nextflow.config @@ -89,7 +89,6 @@ profiles { process.executor = 'local' process.queue = 10 workDir = 'workflow-outputs/work' - process.container = "${params.container_repo}/laava:latest" trace { enabled = true diff --git a/params-local-folder.json b/params-local-folder.json new file mode 100644 index 0000000..f87b88a --- /dev/null +++ b/params-local-folder.json @@ -0,0 +1,18 @@ +{ + "seq_reads_folder": "test/samples/", + "sample_in_metadata": "test/samples/in-metadata.tsv", + "vector_type": "unspecified", + "vector_bed": "test/samples/sc.annotation.bed", + "vector_fa": "test/samples/sc.construct.fasta", + "packaging_fa": "test/fasta/packaging.fa", + "host_fa": "test/fasta/hg38.chr19trunc-chrM.fa", + "itr_label_1": "ITR-L", + "itr_label_2": "ITR-R", + "repcap_name": "pRep2Cap9", + "helper_name": "pHelper", + "lambda_name": "Lambda", + "target_gap_threshold": 200, + "max_allowed_outside_vector": 10, + "max_allowed_missing_flanking": 70, + "container_version": ":latest" +} diff --git a/params-local-no-file-sc.json b/params-local-min.json similarity index 88% rename from params-local-no-file-sc.json rename to params-local-min.json index efa4052..0f39879 100644 --- a/params-local-no-file-sc.json +++ b/params-local-min.json @@ -1,6 +1,5 @@ { "seq_reads_file": "test/samples/sc.subsample005.bam", - "vector_type": "scaav", "vector_bed": "test/samples/sc.annotation.bed", "vector_fa": "test/samples/sc.construct.fasta", "container_version": ":latest" diff --git a/params-local-sc-no-ff.json b/params-local-sc.json similarity index 95% rename from params-local-sc-no-ff.json rename to params-local-sc.json index ba6dc76..2c3b390 100644 --- a/params-local-sc-no-ff.json +++ b/params-local-sc.json @@ -1,6 +1,6 @@ { "seq_reads_file": "test/samples/sc.subsample005.bam", - "vector_type": "scaav", + "vector_type": "sc", "vector_bed": "test/samples/sc.annotation.bed", "vector_fa": "test/samples/sc.construct.fasta", "packaging_fa": "test/fasta/packaging.fa", diff --git a/params-local-ss-with-ff.json b/params-local-ss.json similarity index 95% rename from params-local-ss-with-ff.json rename to params-local-ss.json index d78de89..0ddce15 100644 --- a/params-local-ss-with-ff.json +++ b/params-local-ss.json @@ -1,6 +1,6 @@ { "seq_reads_file": "test/samples/ss.subsample005.bam", - "vector_type": "ssaav", + "vector_type": "ss", "vector_bed": "test/samples/ss.annotation.bed", "vector_fa": "test/samples/ss.construct.fasta", "packaging_fa": "test/fasta/packaging.fa", diff --git a/pyproject.toml b/pyproject.toml index a4921b9..1dccde4 100644 --- a/pyproject.toml +++ b/pyproject.toml @@ -8,16 +8,23 @@ target-version = "py39" select = ["ALL"] ignore = [ "ANN001", + "ANN101", "ANN201", "COM812", + "D101", + "D102", "D103", "D211", "D213", "E501", "EM102", + "INP001", "ISC001", + "PD901", "PLR0913", + "PTH110", "S101", "T201", + "TD", "TRY003", ] diff --git a/src/__init__.py b/src/__init__.py new file mode 100644 index 0000000..e69de29 diff --git a/src/calculate_rdata.R b/src/calculate_rdata.R deleted file mode 100755 index 8480933..0000000 --- a/src/calculate_rdata.R +++ /dev/null @@ -1,186 +0,0 @@ -#!/usr/bin/env Rscript -library(tidyverse) - -# Hush a benign message about "grouped output" -options(dplyr.summarise.inform = FALSE) - - -working_dir = getwd() -message(paste("Working directory:", working_dir)) - -args = commandArgs(trailingOnly = TRUE) - -r_params = list() -r_params$input_prefix = args[1] -r_params$annot_filename = args[2] # ex: annotation.txt -r_params$sample_id = args[3] -r_params$vector_type = args[4] -r_params$flipflop_summary = '' -if (length(args) > 4) { - r_params$flipflop_summary = args[5] -} -message("Parameters:") -print(r_params) - - -# Sort order -valid_types <- c('ssAAV', 'scAAV', 'host', 'repcap', 'helper', 'lambda', 'unmapped', 'chimeric') -valid_subtypes <- c('full', 'full-gap', 'left-partial', 'right-partial', 'wtITR-partial', 'mITR-partial', 'partial', 'backbone', 'vector+backbone') - - -# ---------------------------------------------------------- -## Read the annotation file to find the vector target region -# ---------------------------------------------------------- -# e.g. -# NAME=myHost;TYPE=host; -# NAME=myVector;TYPE=vector;REGION=1795-6553; -# NAME=mRepCap;TYPE=repcap;REGION=1895-5987; - -TARGET_REGION_START <- 0 -TARGET_REGION_END <- 0 -TARGET_REGION_START_REPCAP <- 0 -TARGET_REGION_END_REPCAP <- 0 - -annot <- read.table(r_params$annot_filename) -for (i in 1:dim(annot)[1]) { - if (unlist(strsplit(annot[i, ], ';'))[2] == 'TYPE=vector') { - p <- unlist(strsplit(annot[i, ], ';'))[3]; - s_e <- as.integer(unlist(strsplit(unlist(strsplit(p, '='))[2], '-'))); - TARGET_REGION_START <- s_e[1]; - TARGET_REGION_END <- s_e[2]; - } else if (unlist(strsplit(annot[i, ], ';'))[2] == 'TYPE=repcap') { - p <- unlist(strsplit(annot[i, ], ';'))[3]; - s_e <- as.integer(unlist(strsplit(unlist(strsplit(p, '='))[2], '-'))); - TARGET_REGION_START_REPCAP <- s_e[1]; - TARGET_REGION_END_REPCAP <- s_e[2]; - } -} - - -x.all.summary <- read_tsv(paste0(r_params$input_prefix, '.summary.tsv'), show_col_types = FALSE) %>% - mutate(map_start = map_start0, map_end = map_end1) %>% - mutate(SampleID = r_params$sample_id, .before = read_id) -write_tsv(x.all.summary, paste0(r_params$input_prefix, ".alignments.tsv")) - -x.all.err <- read_tsv(paste0(r_params$input_prefix, '.nonmatch_stat.tsv.gz'), show_col_types = FALSE) %>% - mutate(SampleID = r_params$sample_id, .before = read_id) -x.all.read <- read_tsv(paste0(r_params$input_prefix, '.per_read.tsv'), show_col_types = FALSE) %>% - mutate(SampleID = r_params$sample_id, .before = read_id) - -x.all.err[x.all.err$type == 'D', "type"] <- 'deletion' -x.all.err[x.all.err$type == 'I', "type"] <- 'insertion' -x.all.err[x.all.err$type == 'X', "type"] <- 'mismatch' -x.all.err[x.all.err$type == 'N', "type"] <- 'gaps' - - -# ---------------------------------------------------------- -# produce stats for vector only (ssAAV or scAAV) -# ---------------------------------------------------------- - -x.read.vector <- filter(x.all.read, assigned_type %in% c('scAAV', 'ssAAV')) -x.err.vector <- filter(x.all.err, read_id %in% x.read.vector$read_id) -x.summary.vector <- filter(x.all.summary, read_id %in% x.read.vector$read_id) - - -total_num_reads <- dim(x.read.vector)[1] - -total_err <- dim(x.err.vector)[1] -x.err.vector$pos0_div <- (x.err.vector$pos0 %/% 10 * 10) -df.err.vector <- x.err.vector %>% - group_by(pos0_div, type) %>% - summarise(count = n()) - -x.err.vector$type_len_cat <- "1-10" -x.err.vector[x.err.vector$type_len > 10, "type_len_cat"] <- "11-100" -x.err.vector[x.err.vector$type_len > 100, "type_len_cat"] <- "100-500" -x.err.vector[x.err.vector$type_len > 500, "type_len_cat"] <- ">500" -x.err.vector$type_len_cat <- ordered(x.err.vector$type_len_cat, levels = c('1-10', '11-100', '100-500', '>500')) -write_tsv(x.err.vector, paste0(r_params$input_prefix, ".sequence-error.tsv")) - -x.read.vector$subtype <- x.read.vector$assigned_subtype -# Call "other" all complex and multi-part AAV alignments -x.read.vector[!x.read.vector$subtype %in% valid_subtypes, "subtype"] <- 'other' -# Call "snapback" any scAAV with an ITR-containing partial alignment but no full -# alignment -if (r_params$vector_type == "ssaav") { - x.read.vector[((x.read.vector$assigned_type == "scAAV") & - (x.read.vector$assigned_subtype == "left-partial") - ), "subtype"] <- "left-snapback" - x.read.vector[((x.read.vector$assigned_type == "scAAV") & - (x.read.vector$assigned_subtype == "right-partial") - ), "subtype"] <- "right-snapback" -} - -total_read_count.vector <- sum(x.read.vector$effective_count) -df.read.vector1 <- x.read.vector %>% - group_by(assigned_type) %>% - summarise(e_count = sum(effective_count)) %>% - mutate(freq = round(e_count * 100 / total_read_count.vector, 2)) -df.read.vector1 <- df.read.vector1[order(-df.read.vector1$freq), ] - - -df.read.vector2 <- x.read.vector %>% - group_by(assigned_type, assigned_subtype) %>% - summarise(e_count = sum(effective_count)) %>% - mutate(freq = round(e_count * 100 / total_read_count.vector, 2)) -df.read.vector2 <- df.read.vector2[order(-df.read.vector2$freq), ] - - -x.all.read[is.na(x.all.read$assigned_type), "assigned_type"] <- 'unmapped' -x.all.read[grep("|", as.character(x.all.read$assigned_type), fixed = T), "assigned_type"] <- 'chimeric' -x.all.read[!(x.all.read$assigned_type %in% valid_types), "assigned_type"] <- 'other' -x.all.read[!(x.all.read$assigned_subtype %in% valid_subtypes), "assigned_subtype"] <- 'other' -write_tsv(x.all.read, paste0(r_params$input_prefix, ".readsummary.tsv")) - - -total_read_count.all <- sum(x.all.read$effective_count) #dim(x.all.read)[1] -df.read1 <- x.all.read %>% - group_by(assigned_type) %>% - summarise(e_count = sum(effective_count)) %>% - mutate(freq = round(e_count * 100 / total_read_count.all, 2)) -df.read1 <- df.read1[order(-df.read1$freq), ] - - -# ---------------------------------------------------------- -# Stats and plot for flip/flop analysis (if available) -# ---------------------------------------------------------- - -if (file.exists(r_params$flipflop_summary)) { - df.read.ssaav <- dplyr::filter(df.read.vector2, assigned_type == 'ssAAV') %>% - filter( - assigned_subtype == 'full' | - assigned_subtype == 'right-partial' | - assigned_subtype == 'left-partial' - ) %>% - select(e_count) %>% - as.data.frame() - total_ssaav <- sum(df.read.ssaav$e_count) - - data.flipflop <- read.table(r_params$flipflop_summary, - sep = '\t', - header = T - ) - df.flipflop <- data.flipflop %>% - group_by(type, subtype, leftITR, rightITR) %>% - summarise(count = n()) - scff <- filter(df.flipflop, type == 'scAAV') - ssff <- filter(df.flipflop, type == 'ssAAV') - - # Double single-stranded counts if appropriate - numssff <- sum(ssff$count) - if (is.numeric(numssff) & is.numeric(total_ssaav)) { - if (total_ssaav > 0 & numssff > 0 & numssff * 2 == total_ssaav) { - ssff <- ssff %>% mutate(count = count * 2) - } else { - ssff <- ssff %>% mutate(count = count) - } - } - # Write TSV of flip flop configurations - fftbl <- bind_rows(scff, ssff) - write_tsv(fftbl, paste0(r_params$input_prefix, ".flipflop.tsv")) -} - - -## For downstream consumers - -save.image(file = paste0(r_params$input_prefix, ".Rdata")) diff --git a/src/create_report.R b/src/create_report.R index 08a2f06..5fb76d5 100755 --- a/src/create_report.R +++ b/src/create_report.R @@ -6,24 +6,25 @@ message(paste("Working directory:", working_dir)) args = commandArgs(trailingOnly = TRUE) -rdata_path = args[1] +input_params = list( + path_prefix = args[1], + vector_type = args[2], + annotation_txt = args[3] +) +message("Parameters:") +print(input_params) +# Find the report template relative to this script's filesystem location rmd_dir = dirname(sub("--file=", "", commandArgs(trailingOnly = FALSE)[4])) rmd_path = paste0(rmd_dir, "/report.Rmd") message(paste("Report template location:", rmd_path, sep = " ")) -input_prefix = fs::path_ext_remove(rdata_path) -out_path = paste0(input_prefix, "_AAV_report") # Adds .html and .pdf automatically +#path_prefix = fs::path_ext_remove(input_params$path_prefix) +out_path = paste0(input_params$path_prefix, "_AAV_report") # Adds .html and .pdf automatically out_dir = dirname(out_path) out_filename = basename(out_path) message(paste("Output location:", out_path, sep = " ")) -input_params = list( - rdata_path = rdata_path -) -message("Parameters:") -print(input_params) - rmarkdown::render( rmd_path, output_format = "all", diff --git a/src/get_flipflop_config.py b/src/get_flipflop_config.py index a56a257..686e01a 100755 --- a/src/get_flipflop_config.py +++ b/src/get_flipflop_config.py @@ -1,17 +1,19 @@ #!/usr/bin/env python3 """Get ITR flip flop configurations. -Must have already run `summarize_AAV_alignment.py` to get a .tagged.BAM file! +Must have already run `summarize_alignment.py` to get a .tagged.BAM file! """ +from __future__ import annotations + import csv +import gzip from typing import NamedTuple import parasail import pysam from Bio import SeqIO - SW_SCORE_MATRIX = parasail.matrix_create("ACGT", 2, -5) SEQ_AAV2 = dict( @@ -83,7 +85,7 @@ def identify_flip_flop(r, ff_seq): ): raise RuntimeError( "Input BAM records must have a `AX` tag assigned by first running " - "summarize_AAV_alignment.py. Abort!" + "summarize_alignment.py. Abort!" ) config_left, config_right = "unclassified", "unclassified" @@ -127,12 +129,12 @@ def identify_flip_flop(r, ff_seq): def load_per_read_info(fname): """Load per-read info, keyed by read IDs, from a CSV file.""" - with open(fname) as in_csv: - read_info = {r["read_id"]: r for r in csv.DictReader(in_csv, delimiter="\t")} + with gzip.open(fname, "rt") as in_tsv: + read_info = {r["read_id"]: r for r in csv.DictReader(in_tsv, delimiter="\t")} return read_info -def main(per_read_csv, tagged_bam, output_prefix, flipflop_fasta): +def main(per_read_tsv, tagged_bam, output_prefix, flipflop_fasta): """Entry point.""" OUT_FIELDS = ["name", "type", "subtype", "start", "end", "leftITR", "rightITR"] @@ -141,24 +143,24 @@ def main(per_read_csv, tagged_bam, output_prefix, flipflop_fasta): else: flipflop_seqs = FlipFlopSeqSet.from_fasta(flipflop_fasta) - read_info = load_per_read_info(per_read_csv) + read_info = load_per_read_info(per_read_tsv) - with open(output_prefix + ".flipflop_assignments.tsv", "w") as fout: + with gzip.open(output_prefix + ".flipflop.tsv.gz", "wt") as fout: out_tsv = csv.writer(fout, delimiter="\t") out_tsv.writerow(OUT_FIELDS) reader = pysam.AlignmentFile(open(tagged_bam), "rb", check_sq=False) out_bam_full = pysam.AlignmentFile( - open(output_prefix + ".vector-full-flipflop.bam", "w"), + open(output_prefix + ".flipflop-full.bam", "w"), "wb", header=reader.header, ) out_bam_leftp = pysam.AlignmentFile( - open(output_prefix + ".vector-leftpartial-flipflop.bam", "w"), + open(output_prefix + ".flipflop-left-partial.bam", "w"), "wb", header=reader.header, ) out_bam_rightp = pysam.AlignmentFile( - open(output_prefix + ".vector-rightpartial-flipflop.bam", "w"), + open(output_prefix + ".flipflop-right-partial.bam", "w"), "wb", header=reader.header, ) @@ -187,7 +189,7 @@ def main(per_read_csv, tagged_bam, output_prefix, flipflop_fasta): [ r.qname, a_type, - t["AX"], + t["AX"][len("vector-") :], str(r.reference_start), str(r.reference_end), c_l, @@ -210,7 +212,7 @@ def main(per_read_csv, tagged_bam, output_prefix, flipflop_fasta): parser = ArgumentParser() parser.add_argument("sorted_tagged_bam", help="Sorted tagged BAM file") - parser.add_argument("per_read_csv", help="Per read CSV file") + parser.add_argument("per_read_tsv", help="Per read TSV file") parser.add_argument("-o", "--output-prefix", help="Output prefix", required=True) parser.add_argument( "--flipflop-fasta", @@ -221,7 +223,7 @@ def main(per_read_csv, tagged_bam, output_prefix, flipflop_fasta): args = parser.parse_args() main( - args.per_read_csv, + args.per_read_tsv, args.sorted_tagged_bam, args.output_prefix, args.flipflop_fasta, diff --git a/src/get_reference_names.py b/src/get_reference_names.py index be57f01..9ac948b 100755 --- a/src/get_reference_names.py +++ b/src/get_reference_names.py @@ -1,11 +1,14 @@ #!/usr/bin/env python3 -"""Map reference sequence IDs to "source type name" categories for reporting. +"""Map reference sequence IDs to "reference label" categories for reporting. Output is a 2-column TSV with no header: 1. FASTA sequence ID -2. Source type name, one of: "vector", "repcap", "helper", "host", "lambda" +2. Reference label, one of: "vector", "repcap", "helper", "host", "lambda", or the original + sequence ID if it's not one of those. """ +from __future__ import annotations + import argparse import logging from pathlib import Path @@ -26,7 +29,7 @@ def _main(args): - out_rows = [] + out_rows = [("Name", "Label")] # Vector sequence -- should be just 1 in the FASTA; label it "vector" vector_rec = SeqIO.read(args.vector, "fasta") @@ -35,8 +38,8 @@ def _main(args): # Packaging sequences -- multi-FASTA; apply renaming if args.packaging: packaging_name_map = { - seq_id: source_type - for seq_id, source_type in [ + seq_id: reference_label + for seq_id, reference_label in [ (args.repcap_name, "repcap"), (args.helper_name, "helper"), (args.lambda_name, "lambda"), diff --git a/src/guess_vector_type_length.py b/src/guess_vector_type_length.py new file mode 100755 index 0000000..33190dd --- /dev/null +++ b/src/guess_vector_type_length.py @@ -0,0 +1,56 @@ +#!/usr/bin/env python3 +"""Infer single stranded (ssAAV) vs. self-complementary (scAAV) vector type. + +Approach: +- scAAV packages best when the expression cassette (ITR to ITR) is 2.3-2.4 kb long. +- ssAAV constructs are prone to unresolved dimers when the length is much less than + 4.7kb; the drug product is generally poor for lengths below 4.0kb and stuffer + sequences are necessary to rescue the construct. +- Therefore, we read the length of the vector's annotated ITR-to-ITR region to determine + the length of the expression cassette. If this length is below a threshold, we report + scAAV, otherwise ssAAV. +- If the heuristic guesses incorrectly, the mistake will be prominent in the report: + most vector reads will be marked as "other-vector" instead of "scAAV" or "ssAAV". +""" + +from __future__ import annotations + +import argparse +import sys + +from summarize_alignment import load_annotation_file + +SC_MAX_THRESHOLD = 2300 + + +def length_from_annotation(fname: str) -> int: + """Read annotation.txt to calculate the expression cassette length.""" + cassette_len = -1 + for anno in load_annotation_file(fname).values(): + if anno["label"] == "vector": + ref_coords = anno["region"] + if ref_coords is not None: + start1, end = ref_coords + cassette_len = end - start1 + 1 + break + return cassette_len + + +if __name__ == "__main__": + AP = argparse.ArgumentParser(description=__doc__) + AP.add_argument("ann_file", help="Vector annotation (.txt)") + AP.add_argument( + "-t", + "--sc-max-threshold", + default=SC_MAX_THRESHOLD, + type=int, + help="""Maximum length of the expression cassette, including ITRs, in the + given vector annotation to report as scAAV. [Default: %(default)d]""", + ) + args = AP.parse_args() + cassette_len = length_from_annotation(args.ann_file) + print("Expression cassette length is", cassette_len, file=sys.stderr) + if cassette_len <= args.sc_max_threshold: + print("sc") + else: + print("ss") diff --git a/src/guess_vector_type_mapping.py b/src/guess_vector_type_mapping.py new file mode 100755 index 0000000..485bc6b --- /dev/null +++ b/src/guess_vector_type_mapping.py @@ -0,0 +1,66 @@ +#!/usr/bin/env python3 +"""Infer single stranded (ssAAV) vs. self-complementary (scAAV) vector type. + +Approach: +- scAAV reads aligned to the vector contig almost always have two alignments (forward + and reverse-complement), with rare single alignments coming from contaminants and the + plasmid backbone. +- ssAAV reads aligned to the vector more often have single alignments; reads with two + alignments most often come from "snapback" vector genomes. +- Therefore, we calculate the fraction of reads aligned to the vector contig that have + exactly one alignment. If this fraction is below a threshold, we report scAAV, + otherwise ssAAV. +""" + +from __future__ import annotations + +import argparse +import collections +import sys + +import pysam + +SC_MAX_THRESHOLD = 0.1 + + +def count_alignments(sam_fname, vector_name): + """Collect each read's length and aligned suffix counts.""" + + def filter_records(): + reader = pysam.AlignmentFile(sam_fname, "r", check_sq=False) + for rec in reader: + if not rec.is_mapped: + continue + if vector_name and rec.reference_name != vector_name: + continue + _movie_id, read_num, _suffix = rec.qname.split("/", 2) + yield read_num + + n_aln_per_read = collections.Counter(filter_records()) + histo_n_aln = collections.Counter(n_aln_per_read.values()) + print(histo_n_aln, file=sys.stderr) + n_single = histo_n_aln[1] + total = sum(histo_n_aln.values()) + frac_single = n_single / total + print(f"{n_single} / {total} = {frac_single} singly-aligned reads", file=sys.stderr) + return frac_single + + +if __name__ == "__main__": + AP = argparse.ArgumentParser(description=__doc__) + AP.add_argument("sam_file", help="Read alignment in SAM format.") + AP.add_argument("-v", "--vector-name", help="Vector reference sequence name.") + AP.add_argument( + "-t", + "--sc-max-threshold", + default=SC_MAX_THRESHOLD, + type=float, + help="""Maximum fraction of singly-aligned reads for this sample to be reported + as self-complementary AAV. [Default: %(default)f]""", + ) + args = AP.parse_args() + frac = count_alignments(args.sam_file, args.vector_name) + if frac <= args.sc_max_threshold: + print("sc") + else: + print("ss") diff --git a/bin/make_report.sh b/src/make_report.sh similarity index 70% rename from bin/make_report.sh rename to src/make_report.sh index 2c35b1a..b200fbb 100755 --- a/bin/make_report.sh +++ b/src/make_report.sh @@ -1,5 +1,5 @@ #!/bin/bash -ex -sample_name=$1 +sample_id=$1 vector_type=$2 target_gap_threshold=$3 max_allowed_outside_vector=$4 @@ -20,16 +20,23 @@ else echo "Reads $mapped_reads_sam appear to be in SAM format" fi +if [ "$vector_type" == "unspecified" ]; then + vector_type=$(guess_vector_type_length.py "$annotation_txt") + echo "Inferred vector_type: $vector_type" +fi + echo -echo "Starting summarize_AAV_alignment" -summarize_AAV_alignment.py \ - "$mapped_reads_sam" "$annotation_txt" "$sample_name" \ +echo "Starting summarize_alignment" +summarize_alignment.py \ + "$mapped_reads_sam" "$annotation_txt" "$sample_id" \ + --sample-id="$sample_id" \ + --vector-type="$vector_type" \ --target-gap-threshold=$target_gap_threshold \ --max-allowed-outside-vector=$max_allowed_outside_vector \ --max-allowed-missing-flanking=$max_allowed_missing_flanking \ --cpus $(nproc) -echo "Finished summarize_AAV_alignment" +echo "Finished summarize_alignment" ls -Alh if [[ -n "$flipflop_name" || -n "$flipflop_fa" ]]; then @@ -47,25 +54,17 @@ if [[ -n "$flipflop_name" || -n "$flipflop_fa" ]]; then echo echo "Starting get_flipflop_config" get_flipflop_config.py \ - "${sample_name}.tagged.bam" "${sample_name}.per_read.tsv" \ + "${sample_id}.tagged.bam" "${sample_id}.per_read.tsv.gz" \ $ff_opt \ - -o "$sample_name" + -o "$sample_id" echo "Finished get_flipflop_config" ls -Alh - flipflop_assignments="${sample_name}.flipflop_assignments.tsv" else echo "Skipping flip/flop analysis" - flipflop_assignments="" fi -echo -echo "Starting calculate_rdata" -calculate_rdata.R "./${sample_name}" "$annotation_txt" "$sample_name" "$vector_type" "$flipflop_assignments" -echo "Finished calculate_rdata" -ls -Alh - echo echo "Starting create_report" -create_report.R "./${sample_name}.Rdata" +create_report.R "./${sample_id}" "$vector_type" "$annotation_txt" echo "Finished create_report" ls -Alh diff --git a/bin/map_reads.sh b/src/map_reads.sh similarity index 72% rename from bin/map_reads.sh rename to src/map_reads.sh index b8c33d3..0dc1047 100755 --- a/bin/map_reads.sh +++ b/src/map_reads.sh @@ -36,13 +36,19 @@ fi threads=$(nproc) minimap2 --eqx -a --secondary=no -t $threads all_refs.fa "$reads_fn" > tmp.mapped.sam # Sort the mapped reads by name -samtools sort -@ $threads -n -O SAM -o "$sample_name.sort_by_name.sam" tmp.mapped.sam +name_sam="$sample_name.sort_by_name.sam" +samtools sort -@ $threads -n -O SAM -o "$name_sam" tmp.mapped.sam # Make a position-sorted BAM output file for other downstream consumers -out_bam="$sample_name.sort_by_pos.bam" +pos_bam="$sample_name.sort_by_pos.bam" # Drop unmapped reads -samtools view -@ $threads --fast -F 4 -o tmp.sorted.bam tmp.mapped.sam -samtools sort -@ $threads -o "$out_bam" tmp.sorted.bam -samtools index "$out_bam" +samtools view -@ $threads --fast -o tmp.sorted.bam tmp.mapped.sam +samtools sort -@ $threads -o "$pos_bam" tmp.sorted.bam +samtools index "$pos_bam" +# Logging ls -Alh +echo +samtools flagstat "$name_sam" +echo +samtools idxstats "$pos_bam" diff --git a/src/match_metadata_to_files.py b/src/match_metadata_to_files.py new file mode 100755 index 0000000..7a979c8 --- /dev/null +++ b/src/match_metadata_to_files.py @@ -0,0 +1,52 @@ +#!/usr/bin/env python +"""Read sample IDs and names from a TSV and match to filenamess in the given folder. + +Print matched sample ID, name, and file path to stdout, separated by tabs. + +Only emit file paths matching a given sample ID; if a file in the folder matches the +extension glob (.bam/fastq(.gz)), but does not match any sample ID in the input TSV, +then it will be skipped. +""" + +import argparse +import csv +import sys +from pathlib import Path + +AP = argparse.ArgumentParser(__doc__) +AP.add_argument("sample_in_metadata", type=Path) +AP.add_argument("sample_folder", type=Path) +args = AP.parse_args() + + +VALID_EXTENSIONS = (".bam", ".fastq", ".fastq.gz", ".fq", ".fq.gz") +available_files = [ + f for f in Path(args.sample_folder).iterdir() if f.name.endswith(VALID_EXTENSIONS) +] +print("Available files:", available_files, file=sys.stderr) + +with Path(args.sample_in_metadata).open() as infile: + reader = csv.DictReader(infile, dialect="excel-tab") + line_no = -1 + for line_no, row in enumerate(reader): # noqa: B007 + sample_id = row.get("sample_unique_id") + sample_name = row.get("sample_display_name") + if not sample_id or not sample_name: + sys.exit( + "Error: The given metadata TSV file is missing required columns " + "'sample_unique_id' or 'sample_display_name'." + ) + + matching_files = [f for f in available_files if sample_id in f.name] + if len(matching_files) != 1: + sys.exit( + f"Error: sample_unique_id '{sample_id}' matches {len(matching_files)} " + "files. Expected exactly one match." + ) + + seq_reads_file = matching_files[0] + print(sample_id, sample_name, seq_reads_file.name, sep="\t") + + if line_no == -1: + sys.exit("Error: The TSV file is empty or contains no valid data.") + print(f"Loaded {line_no + 1} sample paths and identifiers", file=sys.stderr) diff --git a/src/prepare_annotation.py b/src/prepare_annotation.py index 131ccec..117d772 100755 --- a/src/prepare_annotation.py +++ b/src/prepare_annotation.py @@ -23,13 +23,15 @@ - NAME is a sequence name/ID used in the reference sequence files that reads will be mapped to. - - TYPE is the source type of the reference sequence -- one of 'vector', 'helper', - 'repcap', 'host', or 'lambda' (not used here). + - TYPE is the source "type" or label of the reference sequence -- one of 'vector', 'helper', + 'repcap', 'host', or 'lambda'. - There must be exactly one line where TYPE is 'vector'. - The 'vector' line also has a REGION field with the 1-based start and end positions. In AAV, this is the payload region including the ITRs. """ +from __future__ import annotations + import argparse import logging import sys @@ -40,13 +42,13 @@ class AnnRow(NamedTuple): seq_name: str - source_type: str + ref_label: str start1: int end: int -# From summarize_AAV_alignment.py -ANNOT_TYPES = {"vector", "repcap", "helper", "lambda", "host"} +# From summarize_alignment.py +KNOWN_ANNOT_LABELS = {"vector", "repcap", "helper", "lambda", "host"} def read_annotation_bed(fname: str, itr_labels: list[str]): @@ -143,56 +145,58 @@ def read_annotation_bed(fname: str, itr_labels: list[str]): def read_reference_names(fname: str): - """Read a 2-column TSV of reference sequence names and source types.""" + """Read a 2-column TSV of reference sequence names and labels.""" with Path(fname).open() as infile: - for line in infile: - seq_name, source_type = line.split() - if source_type in ANNOT_TYPES: - yield AnnRow(seq_name, source_type, None, None) - else: + # Skip header + lines = iter(infile) + next(infile) + for line in lines: + seq_name, ref_label = line.split() + if ref_label not in KNOWN_ANNOT_LABELS: logging.info( - "Nonstandard reference source type %s; " - "the standards are: vector, repcap, helper, host", - source_type, + "Nonstandard reference label %s; " + "the known labels are: vector, repcap, helper, host", + ref_label, ) + yield AnnRow(seq_name, ref_label, None, None) def write_annotation_txt(out_fname: str, bed_rows: dict, other_rows: Iterable): """Write PacBio-style annotations to `out_fname`. - Take the vector annotations and non-'vector' sequence names and source types, format + Take the vector annotations and non-'vector' sequence names and labels, format it for annotation.txt, and append it to the same output file. Skip any duplicate 'vector' sequence label appearing in the other references, and - catch if a sequence name is reused across multiple source types. + catch if a sequence name is reused across multiple labels. """ vector_row = bed_rows["vector"] repcap_row = bed_rows["repcap"] with Path(out_fname).open("w+") as outf: outf.write("NAME={};TYPE={};REGION={}-{};\n".format(*vector_row)) - seen_seq_names_and_sources = {vector_row.seq_name: vector_row.source_type} + seen_seq_names_and_labels = {vector_row.seq_name: vector_row.ref_label} if repcap_row: outf.write("NAME={};TYPE={};REGION={}-{};\n".format(*repcap_row)) - seen_seq_names_and_sources[repcap_row.seq_name] = repcap_row.source_type + seen_seq_names_and_labels[repcap_row.seq_name] = repcap_row.ref_label for orow in other_rows: - if orow.source_type == "vector": + if orow.ref_label == "vector": if orow.seq_name != vector_row.seq_name: raise RuntimeError( - "Source type 'vector' listed in additional " + "Reference label 'vector' listed for additional " f"reference names, but sequence name {orow.seq_name} does not " f"match the previously given {vector_row.seq_name}" ) continue - if orow.seq_name in seen_seq_names_and_sources: - prev_type = seen_seq_names_and_sources[orow.seq_name] - if orow.source_type != prev_type: + if orow.seq_name in seen_seq_names_and_labels: + prev_type = seen_seq_names_and_labels[orow.seq_name] + if orow.ref_label != prev_type: raise RuntimeError( f"Sequence name {orow.seq_name} listed with " - f"different source types: first {prev_type}, then " - f"{orow.source_type}" + f"different labels: first {prev_type}, then " + f"{orow.ref_label}" ) continue - outf.write("NAME={seq_name};TYPE={source_type};\n".format(**orow._asdict())) + outf.write("NAME={seq_name};TYPE={ref_label};\n".format(**orow._asdict())) if __name__ == "__main__": @@ -203,7 +207,7 @@ def write_annotation_txt(out_fname: str, bed_rows: dict, other_rows: Iterable): ) AP.add_argument( "reference_names", - help="Reference sequence names and their sources, in 2 columns.", + help="Reference sequence names and their labels, in 2 columns.", ) AP.add_argument("itr_labels", nargs="*", help="ITR label(s) in annotation BED") AP.add_argument("-o", "--output", help="Output filename (*.txt).") diff --git a/src/report.Rmd b/src/report.Rmd index 6e8008b..b3ee9bb 100644 --- a/src/report.Rmd +++ b/src/report.Rmd @@ -6,7 +6,11 @@ output: pdf_document: toc: true params: - rdata_path: + path_prefix: + value: "" + vector_type: + value: "" + annotation_txt: value: "" --- @@ -16,6 +20,9 @@ library(flextable) # Avoid scientific notation options(scipen = 999) +# Hush a benign message about "grouped output" +options(dplyr.summarise.inform = FALSE) + # Configure Rmarkdown/knitr/pandoc processing knitr::opts_chunk$set(echo = FALSE, fig.align = "center", @@ -30,87 +37,206 @@ set_flextable_defaults( table.layout = "autofit", theme_fun = "theme_vanilla" ) - -# Load precomputed dataframes etc. -load(params$rdata_path) +# Load sample metadata +meta <- read_tsv(paste0(params$path_prefix, '.metadata.tsv'), show_col_types = FALSE) ``` --- title: "AAV Sequence Analysis" -subtitle: 'Sample: `r r_params$sample_id`' +subtitle: 'Sample name: `r meta$sample_display_name`' date: 'Date: `r format(Sys.Date())`' --- +# Analysis context + +| | Value | +|:---------------------:|----------------------------| +| Sample unique ID | `r meta$sample_unique_id` | +| Sequencing run ID | `r meta$sequencing_run_id` | +| Construct vector type | `r params$vector_type`AAV | + `\newpage`{=latex} -# Read type classification + +# Read-based AAV vector type classification ## Definitions +Table: Reference label definitions. + +Reference Label |Definition +:-----------------:|---------------------------------------------------- +vector |Read originates from the vector plasmid. +repcap |Read originates from the RepCap plasmid. The Rep gene encodes four proteins (Rep78, Rep68, Rep52, and Rep40), which are required for viral genome replication and packaging, while Cap expression gives rise to the viral capsid proteins (VP; VP1/VP2/VP3), which form the outer capsid shell that protects the viral genome, as well as being actively involved in cell binding and internalization. +helper |Read originates from the helper plasmid. In addition to Rep and Cap, AAV requires a helper plasmid containing genes from adenovirus. These genes (E4, E2a and VA) mediate AAV replication. +host |Read originates from the host genome that is given (e.g. hg38, CHM13). +chimeric-vector |One part of the read aligns to the vector plasmid, while another part of the same read aligns to a different reference sequence. +chimeric-nonvector |The read consists of fragments that align to two or more different reference sequences, neither of which is the vector plasmid. + + +Table: Assigned type definitions. + Assigned Type|Definition -------------:|---------------------------------------------------- -scAAV |Self-complementary AAV where one half of the payload region is a reverse complement of the other, resulting in an intra-molecular double-stranded DNA template. A sequencing read is inferred as scAAV if it has both a primary and supplementary alignment to the vector genome. -ssAAV |AAV where the resulting DNA template is expected to be single-stranded, as opposed to self-complementary. A sequencing read is inferred as ssAAV if it has a single alignment to the AAV genome and no complementary secondary alignment. -other |Read consists of a fragment mapping to the vector but with unexpected polarities (e.g. +,-,- or +,+,+) and cannot be well-defined at the moment. This means that the algorithm was not able to distinguish the read either as ssAAV or scAAV by the definitions above, usually due to multiple supplementary alignments on the vector region or other unusual alignment features. -host |Read originates from the host genome that is given (e.g. hg38, CHM13). -repcap |Read originates from the repcap plasmid. The Rep gene encodes four proteins (Rep78, Rep68, Rep52, and Rep40), which are required for viral genome replication and packaging, while Cap expression gives rise to the viral capsid proteins (VP; VP1/VP2/VP3), which form the outer capsid shell that protects the viral genome, as well as being actively involved in cell binding and internalization. -helper |Read originates from the helper plasmid. In addition to Rep and Cap, AAV requires a helper plasmid containing genes from adenovirus. These genes (E4, E2a and VA) mediate AAV replication. -chimeric |Read consists of fragments that map to one or more "genomes" (e.g. vector and host; helper and repcap). +:-----------:|---------------------------------------------------- +ssAAV |Single-stranded AAV vector genome where the resulting DNA template is expected to be single-stranded, as opposed to self-complementary. A sequencing read is inferred as ssAAV if it has a single alignment to the vector plasmid’s ITR-to-ITR payload region and no complementary supplemental alignment. +scAAV |Self-complementary AAV vector genome where one half of the payload region is a reverse complement of the other, resulting in an intramolecular double-stranded DNA template. A sequencing read is inferred as scAAV if it aligns to the payload region in both forward (+) and reverse (-) read directions. +backbone |Read aligns to the vector plasmid sequence but fully outside of the annotated ITR-to-ITR region, indicating that the sequence fragment originated solely from the plasmid backbone. +other-vector |Read consists of a fragment mapping to the vector but with characteristics other than those listed above. -*Note:* Even though ssAAV distinguishes one ITR as the wildtype (wtITR) and the other as the mutated ITR (mITR), we will still refer to them as "left ITR" and "right ITR". For example, "left-partial" would be equivalent to "mITR-partial" in the case where the mITR is the left ITR based on the given genomic coordinates. `
`{=html} ![Single-stranded AAV types (ssAAV). -ssAAV reads must fully map within the vector genome (which can contain the backbone, beyond the ITR region) consisting of a single (primary) alignment. -"ssAAV-full" reads must cover from left ITR to right ITR. -"ssAAV-left-partial" contain the left ITR but are missing the right ITR. -"scAAV-vector+backbone" map partially within the ITR and partially to the backbone. +ssAAV reads are expected to have a single (forward) alignment to the vector genome. +"ssAAV full" reads cover the target region from left ITR to right ITR. +"ssAAV left-partial" contain the left ITR but are missing the right ITR. +"scAAV vector+backbone" reads overlap both the ITR-to-ITR region and the plasmid backbone, beyond the ITR. ](class_def_ssAAV.png) `
`{=html} ![Self-complementary AAV types (scAAV). -scAAV reads must fully map within the vector genome (which can contain the backbone, beyond the ITR region) consisting of both primary and supplementary alignments. +scAAV reads are expected to have both forward and reverse-complementary alignments to the vector genome. The definitions of full, partial, and backbone reads are the same as in ssAAV. ](class_def_scAAV.png) `\break`{=latex} +```{r loadanno, message=FALSE, warning=FALSE} +# ------------------------- +# annotation.txt -> TARGET_REGION_{START,END}(_REPCAP) +# ------------------------- +# Read the annotation file to find the vector target region +# ---------------------------------------------------------- +# e.g. +# NAME=myHost;TYPE=host; +# NAME=myVector;TYPE=vector;REGION=1795-6553; +# NAME=mRepCap;TYPE=repcap;REGION=1895-5987; + +TARGET_REGION_START <- 0 +TARGET_REGION_END <- 0 +TARGET_REGION_START_REPCAP <- 0 +TARGET_REGION_END_REPCAP <- 0 + +annot <- read.table(params$annotation_txt) +for (i in 1:dim(annot)[1]) { + if (unlist(strsplit(annot[i, ], ';'))[2] == 'TYPE=vector') { + p <- unlist(strsplit(annot[i, ], ';'))[3]; + s_e <- as.integer(unlist(strsplit(unlist(strsplit(p, '='))[2], '-'))); + TARGET_REGION_START <- s_e[1]; + TARGET_REGION_END <- s_e[2]; + } else if (unlist(strsplit(annot[i, ], ';'))[2] == 'TYPE=repcap') { + p <- unlist(strsplit(annot[i, ], ';'))[3]; + s_e <- as.integer(unlist(strsplit(unlist(strsplit(p, '='))[2], '-'))); + TARGET_REGION_START_REPCAP <- s_e[1]; + TARGET_REGION_END_REPCAP <- s_e[2]; + } +} +``` + +```{r calculate, message=FALSE, warning=FALSE} +# ------------------------------------- +# alignments.tsv.gz +# ------------------------------------- + +x.all.summary <- read_tsv(paste0(params$path_prefix, '.alignments.tsv.gz'), show_col_types = FALSE) + + +# --------------------------------------- +# per_read.tsv.gz +# --------------------------------------- + +x.all.read <- read_tsv(paste0(params$path_prefix, '.per_read.tsv.gz'), show_col_types = FALSE) + +# Set the display order for categoricals +valid_types <- c('ssAAV', 'scAAV', 'other-vector', 'backbone') +valid_subtypes <- c( + 'full', + 'full-gap', + 'read-through', + 'partial', + 'left-partial', + 'right-partial', + 'itr-partial', + 'left-snapback', + 'right-snapback', + 'snapback', + 'unresolved-dimer', + 'tandem', + 'complex', + 'unclassified', + 'backbone') + +ref_counts <- x.all.read %>% + filter(reference_label != "(unmapped)") %>% + group_by(reference_label) %>% + summarise(e_count = sum(effective_count)) %>% + arrange(desc(e_count)) +ref_levels = c(ref_counts$reference_label, "(unmapped)") + +x.all.read <- x.all.read %>% + mutate( + reference_label = factor(reference_label, levels = ref_levels), + assigned_type = factor(assigned_type, levels = valid_types), + assigned_subtype = factor(assigned_subtype, levels = valid_subtypes)) + +total_read_count_all <- sum(x.all.read$effective_count) + +# Filter to vector-only and sort types/subtypes +x.read.vector <- x.all.read %>% filter(reference_label == "vector") + +total_read_count_vector <- sum(x.read.vector$effective_count) + +x.summary.primary <- filter(x.all.summary, is_mapped == "Y", is_supp == "N") +x.joined.vector <- left_join(x.read.vector, x.summary.primary, by = "read_id", multiple = "first") +``` + # Assigned types by read alignment characteristics -```{r sopt1, message=FALSE, warning=FALSE} +```{r typetable, message=FALSE, warning=FALSE} +df.read1 <- x.all.read %>% + group_by(reference_label, assigned_type) %>% + summarise(e_count = sum(effective_count)) %>% + mutate(freq = round(e_count * 100 / total_read_count_all, 2)) %>% + arrange(reference_label, desc(freq)) + flextable(df.read1) %>% - set_header_labels(values = c("Assigned Type", "Count", "Frequency (%)")) + set_header_labels(values = c("Mapped Reference", "Assigned Type", "Count", "Frequency (%)")) ``` -```{r barpercentreads, message=FALSE, warning=FALSE} -countreads <- df.read1 %>% dplyr::filter(assigned_type != 'Lambda') +```{r typeplots, message=FALSE, warning=FALSE} +countreads <- df.read1 %>% dplyr::filter(reference_label != "lambda") # Bar chart -ggplot(countreads, aes(x = assigned_type, y = freq, fill = assigned_type)) + - geom_bar(stat = 'identity') + - xlab("Sequence") + +ggplot(countreads, aes(x = reference_label, y = freq, fill = assigned_type)) + + geom_bar(stat = "identity") + + scale_x_discrete("Sequence", guide = guide_axis(angle = 30)) + scale_y_continuous("Reads (%)", - limits = c(0, NA), - expand = expansion(mult = c(0, 0.05))) + limits = c(0, 100), + expand = c(0, 0)) # Pie chart -ggplot(countreads, aes(x = "", y = e_count, fill = assigned_type)) + +ggplot(countreads, aes(x = "", y = e_count, fill = reference_label)) + geom_bar(stat = "identity", width = 1) + coord_polar("y", start = 0) + theme_void() ``` -## Single-stranded vs self-complementary frequency +## Frequency of vector assigned types -```{r sopt2, message=FALSE, warning=FALSE} -sopt2 <- df.read.vector1 %>% - mutate(totfreq = round(100 * e_count / total_read_count.all, 2)) +```{r vectypes, message=FALSE, warning=FALSE} +df.read.vector1 <- x.read.vector %>% + group_by(assigned_type) %>% + summarise(e_count = sum(effective_count)) %>% + mutate(freq = round(e_count * 100 / total_read_count_vector, 2)) %>% + arrange(assigned_type, desc(freq)) -flextable(sopt2) %>% +vectypes <- df.read.vector1 %>% + mutate(totfreq = round(100 * e_count / total_read_count_all, 2)) + +flextable(vectypes) %>% set_header_labels(values = c( "Assigned Type", "Count", @@ -119,42 +245,78 @@ flextable(sopt2) %>% )) ``` -# Distribution of read lengths by assigned AAV types +# Distribution of vector read lengths by assigned types ```{r atypeviolin, message=FALSE, warning=FALSE} -allowed_subtypes <- c('full', 'full-gap', 'vector+backbone') - p2.atype_violin <- ggplot( - filter(x.read.vector, assigned_subtype %in% allowed_subtypes), - aes( - x = paste(assigned_type, assigned_subtype, sep = '-'), - y = read_len - ) + x.joined.vector %>% + mutate(assigned_type = factor(assigned_type, levels = valid_types)), + aes(x = assigned_type, y = read_len) ) + geom_violin() + - labs(title = "Distribution of read lengths by assigned AAV type", - x = "Assigned AAV type") + + labs(title = "Distribution of vector read lengths by assigned type", + x = "Assigned type") + scale_y_continuous("Read length", limits = c(0, NA), - expand = expansion(mult = c(0, 0.05))) + - theme(axis.text.x = element_text(angle = -45, hjust = 0)) + expand = expansion(mult = c(0, 0.05))) p2.atype_violin ``` -# Assigned AAV read types detailed analysis -## Assigned AAV types (top 20) +# Assigned subtypes detailed analysis + +## Definitions + +```{asis, echo = params$vector_type == "ss"} +Table: Assigned subtype definitions for single-stranded input vector. + +Assigned Type|Assigned Subtype|Definition +:-----------:|:--------------:|------------------------------------------------ +ssAAV |full |Read aligns to a fragment of the vector originating from the left (upstream) ITR and ending at the right (downstream) ITR of the vector. +ssAAV |full-gap |Read aligns to the vector ITR-to-ITR region, as with “full”, but with a significant number of gaps in the alignment between the ITRs. +ssAAV |read-through |Read aligns to a fragment including the vector as well as plasmid backbone sequence. May imply read-through beyond the right ITR, or reverse packaging if the alignment is to only the left ITR and backbone. +ssAAV |partial |Read aligns to a fragment of the vector originating from within the ITR sequences. +ssAAV |left-partial |Read aligns to a fragment of the vector originating from the left (upstream) ITR of the vector while not covering the right ITR. +ssAAV |right-partial |Read aligns to a fragment of the vector originating from the right (downstream) ITR of the vector while not covering the left ITR. +ssAAV |left-snapback |Read consists of a double-stranded, sub-genomic fragment including only the left ITR and aligned symmetrically to the (+) and (-) strands. +ssAAV |right-snapback |Read consists of a double-stranded, sub-genomic fragment including only the right ITR and aligned symmetrically to the (+) and (-) strands. +other-vector |snapback |Read aligns to a double-stranded fragment in both (+) and (-) strands, but does not include either ITR. +other-vector |unresolved-dimer|Read aligns to a double-stranded fragment covering the full ITR-to-ITR region in both (+) and (-) strands. A dimer in ssAAV context, twice the size of a ssAAVV-full vector genome. +other-vector |tandem |Read has two or more overlapping alignments on the same strand, but none on the reverse strand, indicating tandem duplication of the same region. +other-vector |complex |Read aligns to a double-stranded fragment with asymmetrical and/or multiple alignments on the (+) and (-) strands. +other-vector |unclassified |Read alignment does not match any of the above orientations. +``` + +```{asis, echo = params$vector_type == "sc"} +Table: Assigned subtype definitions for self-complementary input vector. + +Assigned Type|Assigned Subtype|Definition +:-----------:|:--------------:|------------------------------------------------ +scAAV |full |Read aligns to a fragment of the vector originating from the left (upstream) ITR and ending at the right (downstream) ITR of the vector. +scAAV |full-gap |Read aligns to the vector ITR-to-ITR region, as with “full”, but with a significant number of gaps in the alignment between the ITRs. +scAAV |read-through |Read aligns to a fragment including the vector as well as plasmid backbone sequence. May imply read-through beyond the right ITR, or reverse packaging if the alignment is to only the left ITR and backbone. +scAAV |partial |Read aligns to a fragment of the vector originating from within the ITR sequences. +scAAV |itr-partial |Read aligns only to a single-stranded fragment of the vector originating from the left ITR while not covering the right ITR. +scAAV |snapback |Read consists of a double-stranded, sub-genomic fragment including only the left ITR and read alignments in both (+) and (-) strands. +other-vector |tandem |Read has two or more overlapping alignments on the same strand, but none on the reverse strand, indicating tandem duplication of the same region. +other-vector |complex |Read aligns to a double-stranded fragment with asymmetrical and/or multiple alignments on the (+) and (-) strands. +other-vector |unclassified |Read alignment does not match any of the above orientations. +``` + +## Assigned types and subtypes ```{r sopt3, message=FALSE, warning=FALSE} +df.read.vector2 <- x.read.vector %>% + group_by(assigned_type, assigned_subtype) %>% + summarise(e_count = sum(effective_count)) %>% + mutate(freq = round(e_count * 100 / total_read_count_vector, 2)) %>% + arrange(assigned_type, desc(freq)) + sopt3 <- df.read.vector2 %>% - mutate(totfreq = round(100 * e_count / total_read_count.all, 2)) %>% - arrange( - factor(assigned_type, levels = valid_types), - factor(assigned_subtype, levels = valid_subtypes) - ) + mutate(totfreq = round(100 * e_count / total_read_count_all, 2)) -flextable(sopt3[1:min(nrow(sopt3), 20), ]) %>% +flextable(sopt3) %>% set_header_labels( values = c( "Assigned Type", @@ -166,108 +328,22 @@ flextable(sopt3[1:min(nrow(sopt3), 20), ]) %>% ) ``` -## Definitions - -Assigned Subtype|Definition ----------------:|---------------------------------------------------------------- -full |Read alignment includes the entire ITR-to-ITR target vector sequence. -left-partial |Read aligns to a fragment of the vector originating from the left (upstream) ITR of the vector while not covering the right ITR. -right-partial |Read aligns to a fragment of the vector originating from the right (downstream) ITR of the vector while not covering the left ITR. -partial |Read aligns to a fragment of the vector originating from within the ITR sequences. -vector+backbone |Read aligns to a fragment including the vector as well as plasmid backbone sequence. May imply read-through beyond the right ITR, or reverse packaging if the alignment is to only the left ITR and backbone. -backbone |Read aligns to a fragment originating solely from the plasmid backbone sequence. -snapback |Read consists of a double-stranded, sub-genomic fragment including only one ITR and read alignments in both (+) and (-) polarities. (ssAAV only) - - -# Flip/flop considerations - -Term|Definition ----:|---------------- -Flip/Flop|One ITR is formed by two palindromic arms, called B–B' and C–C', embedded in a larger one, A–A'. The order of these palindromic sequences defines the flip or flop orientation of the ITR. ([Read more](https://www.ncbi.nlm.nih.gov/pmc/articles/PMC5655423/)) - - -```{r flipflopplot, message=FALSE, warning=FALSE, results='asis'} -if (exists("df.flipflop")) { - # Generate flip/flop summary plot - ffplot <- df.flipflop %>% - mutate( - class = if_else( - leftITR == 'unclassified' | - rightITR == 'unclassified' | - leftITR == 'unknown' | rightITR == 'unknown', - "unclassifed", - paste(leftITR, rightITR, sep = '-') - ) - ) %>% - group_by(type, subtype, class) %>% - summarize(classct = sum(count)) %>% - filter(subtype == 'vector-full') - ggplot(ffplot, aes(x = type, y = classct, fill = class)) + - geom_bar(stat = 'identity') + - labs(x = 'Assigned type') + - scale_y_continuous("Number of reads", - limits = c(0, NA), - expand = expansion(mult = c(0, 0.05))) - -} else { - cat("No flip/flop analysis results available to display.") -} -``` - -```{r flipflopsc, message=FALSE, warning=FALSE, results='asis'} -if (exists("scff")) { - cat("## Flip/flop configurations, scAAV only\n\n") - if (nrow(scff) > 1) { - flextable(scff) %>% - set_header_labels(values = c("type", "subtype", "leftITR", "rightITR", "count")) - } else { - cat("\nNo scAAV flip/flop analysis results available to display.") - } -} -``` - -```{r flipflopss, message=FALSE, warning=FALSE, results='asis'} -if (exists("ssff")) { - cat("## Flip/flop configurations, ssAAV only\n\n") - if (nrow(ssff) > 1) { - flextable(ssff) %>% - set_header_labels(values = c("type", "subtype", "leftITR", "rightITR", "count")) - } else { - cat("No ssAAV flip/flop analysis results available to display.") - } -} -``` - -# Distribution of read length by subtype +## Distribution of read length by subtype ```{r lenhisto2_subtype, message=FALSE, warning=FALSE} -# scAAV length histogram -p1.scAAV_len_hist <- ggplot(filter(x.read.vector, assigned_type == 'scAAV'), - aes(x = read_len, color = subtype)) + +# Single plot +p1_subtypes_len_hist <- ggplot(filter(x.joined.vector), + aes(x = read_len, color = assigned_subtype)) + geom_freqpoly() + - labs(title = "Distribution of scAAV read length by subtype") + + labs(title = "Distribution of read length by subtype") + scale_x_continuous("Read length (bp)", limits = c(0, NA), expand = expansion(mult = c(0, 0.05))) + scale_y_continuous("Count", limits = c(0, NA), expand = expansion(mult = c(0, 0.05))) - -# ssAAV length histogram -p1.ssAAV_len_hist <- ggplot(filter(x.read.vector, assigned_type == 'ssAAV'), - aes(x = read_len, color = subtype)) + - geom_freqpoly() + - labs(title = "Distribution of ssAAV read length by subtype") + - scale_x_continuous("Read length (bp)", - limits = c(0, NA), - expand = expansion(mult = c(0, 0.05))) + - scale_y_continuous("Count", - limits = c(0, NA), - expand = expansion(mult = c(0, 0.05))) - -p1.scAAV_len_hist -p1.ssAAV_len_hist +p1_subtypes_len_hist ``` @@ -276,16 +352,16 @@ p1.ssAAV_len_hist ## Gene therapy construct ```{r lenhisto2_construct, message=FALSE, warning=FALSE} -p1.map_starts <- ggplot(x.summary.vector, aes(map_start0 + 1, fill = map_subtype)) + +p1.map_starts <- ggplot(x.joined.vector, aes(map_start0 + 1, fill = assigned_subtype)) + geom_histogram(aes(y = after_stat(count) / sum(after_stat(count))), binwidth = 150, boundary = 0, closed = "left") + geom_vline(xintercept = TARGET_REGION_START, - color = 'red', + color = "black", lty = 2) + geom_vline(xintercept = TARGET_REGION_END, - color = 'red', + color = "black", lty = 2) + scale_x_continuous("Mapped reference start position", limits = c(0, NA), @@ -295,34 +371,34 @@ p1.map_starts <- ggplot(x.summary.vector, aes(map_start0 + 1, fill = map_subtype expand = c(0, 0)) + labs(title = "Distribution of mapped read starts on construct") -p1.map_ends <- ggplot(x.summary.vector, aes(map_end1, fill = map_subtype)) + +p1.map_ends <- ggplot(x.joined.vector, aes(map_end1, fill = assigned_subtype)) + geom_histogram(aes(y = after_stat(count) / sum(after_stat(count))), binwidth = 150, boundary = 0, closed = "left") + geom_vline(xintercept = TARGET_REGION_START, - color = 'red', + color = "black", lty = 2) + geom_vline(xintercept = TARGET_REGION_END, - color = 'red', + color = "black", lty = 2) + - scale_x_continuous("mapped reference end position", + scale_x_continuous("Mapped reference end position", limits = c(0, NA), expand = expansion(mult = c(0, 0.05))) + - scale_y_continuous("fraction of reads", + scale_y_continuous("Fraction of reads", limits = c(0, 1), expand = c(0, 0)) + labs(title = "Distribution of mapped read ends on construct") -p1.map_len <- ggplot(x.summary.vector, aes(map_len, fill = map_subtype)) + +p1.map_len <- ggplot(x.joined.vector, aes(map_len, fill = assigned_subtype)) + geom_histogram(aes(y = after_stat(count) / sum(after_stat(count))), binwidth = 150, boundary = 0, closed = "left") + - scale_x_continuous("mapped reference length", + scale_x_continuous("Mapped reference length", limits = c(0, NA), expand = expansion(mult = c(0, 0.05))) + - scale_y_continuous("fraction of reads", + scale_y_continuous("Fraction of reads", limits = c(0, 1), expand = c(0, 0)) + labs(title = "Distribution of mapped spanning region sizes on construct") @@ -335,7 +411,7 @@ p1.map_len ```{r lenhisto2_rc, message=FALSE, warning=FALSE, results='asis'} -x.read.repcap <- filter(x.all.read, assigned_type == 'repcap') +x.read.repcap <- filter(x.all.read, reference_label == 'repcap') # Only render this subsection if enough reads mapped to repcap if (dim(x.read.repcap)[1] > 10) { @@ -408,6 +484,30 @@ if (exists("x.summary.repcap")) { # Distribution of non-matches by reference position +```{r varcalc, message=FALSE, warning=FALSE} +# -------------------------------------------------- +# nonmatch.tsv.gz +# -------------------------------------------------- + +x.all.err <- read_tsv(paste0(params$path_prefix, '.nonmatch.tsv.gz'), show_col_types = FALSE) + +# Filter for ss/scAAV vector only +x.err.vector <- filter(x.all.err, read_id %in% x.read.vector$read_id) + +# Spell out nonmatch types -- from CIGAR codes to words +x.err.vector[x.err.vector$type == 'D', "type"] <- 'deletion' +x.err.vector[x.err.vector$type == 'I', "type"] <- 'insertion' +x.err.vector[x.err.vector$type == 'X', "type"] <- 'mismatch' +x.err.vector[x.err.vector$type == 'N', "type"] <- 'gaps' + +# Round positions down to 10s for plotting +x.err.vector$pos0_div <- (x.err.vector$pos0 %/% 10 * 10) + +df.err.vector <- x.err.vector %>% + group_by(pos0_div, type) %>% + summarise(count = n()) +``` + ```{r varplots, message=FALSE, warning=FALSE} p1.err_sub <- ggplot(filter(df.err.vector, type == 'mismatch'), aes(x = pos0_div, y = count)) + @@ -448,6 +548,65 @@ p1.err_ins ``` +# Flip/flop configurations + +Term|Definition +:--:|---------------- +Flip/Flop|One ITR is formed by two palindromic arms, called B–B' and C–C', embedded in a larger one, A–A'. The order of these palindromic sequences defines the flip or flop orientation of the ITR. ([Read more](https://www.ncbi.nlm.nih.gov/pmc/articles/PMC5655423/)) + +```{r ffcalc, message=FALSE, warning=FALSE} +# -------------------------------------------------- +# flipflop.tsv.gz (if available) +# -------------------------------------------------- + +flipflop_tsv <- paste0(params$path_prefix, '.flipflop.tsv.gz') +if (file.exists(flipflop_tsv)) { + data.flipflop <- read_tsv(flipflop_tsv, show_col_types = FALSE) + df.flipflop <- data.flipflop %>% + group_by(type, subtype, leftITR, rightITR) %>% + summarise(count = n()) +} +``` + +```{r ffplot, message=FALSE, warning=FALSE, results='asis'} +if (exists("df.flipflop")) { + # Generate flip/flop summary plot + ffplot <- df.flipflop %>% + mutate( + class = if_else( + leftITR == 'unclassified' | rightITR == 'unclassified', + "unclassified", + paste(leftITR, rightITR, sep = '-') + ) + ) %>% + mutate( + unclass = if_else( class == "unclassified", "unclassified", "classified") + ) %>% + group_by(type, subtype, class, unclass) %>% + summarize(classct = sum(count)) %>% + filter(subtype == 'full') + ggplot(ffplot, aes(x = class, y = classct, fill = unclass)) + + geom_bar(stat = 'identity', show.legend = FALSE) + + labs(x = 'Assigned type') + + scale_y_continuous("Number of reads", + limits = c(0, NA), + expand = expansion(mult = c(0, 0.05))) + +} else { + cat("No flip/flop analysis results available to display.") +} +``` + +```{r fftable, message=FALSE, warning=FALSE, results='asis'} +if (exists("df.flipflop") && (nrow(df.flipflop) > 1)) { + flextable(df.flipflop) %>% + set_header_labels(values = c("type", "subtype", "leftITR", "rightITR", "count")) +} +``` + + +`\break`{=latex} + # Methods This report was generated by an automated analysis of long-read sequencing data from diff --git a/src/summarize_AAV_alignment.py b/src/summarize_alignment.py similarity index 57% rename from src/summarize_AAV_alignment.py rename to src/summarize_alignment.py index 1be7276..ef442bc 100755 --- a/src/summarize_AAV_alignment.py +++ b/src/summarize_alignment.py @@ -1,18 +1,19 @@ #!/usr/bin/env python3 """Summarize the AAV alignment.""" +from __future__ import annotations + import gzip import itertools import logging import os import re -import shutil import subprocess import sys from csv import DictReader, DictWriter from multiprocessing import Process -# import pdb +# import pdb import pysam CIGAR_DICT = { @@ -28,7 +29,7 @@ 9: "B", } -annot_rex = re.compile(r"NAME=(\S+);TYPE=([a-zA-Z]+);(REGION=\d+\-\d+){0,1}") +annot_rex = re.compile(r"NAME=([^;\s]+);TYPE=([^;\s]+);(REGION=\d+\-\d+){0,1}") ccs_rex = re.compile(r"\S+\/\d+\/ccs(\/fwd|\/rev)?") ANNOT_TYPE_PRIORITIES = {"vector": 1, "repcap": 2, "helper": 3, "lambda": 4, "host": 5} @@ -47,26 +48,34 @@ def subset_sam_by_readname_list( exclude_subtype=False, exclude_type=False, ): - qname_list = {} # qname --> (a_type, a_subtype) - for r in DictReader(open(per_read_tsv), delimiter="\t"): - # pdb.set_trace() - if ( - wanted_types is None - or (not exclude_type and r["assigned_type"] in wanted_types) - or (exclude_type and r["assigned_type"] not in wanted_types) - ) and ( - wanted_subtypes is None - or (not exclude_subtype and (r["assigned_subtype"] in wanted_subtypes)) - or (exclude_subtype and (r["assigned_subtype"] not in wanted_subtypes)) - ): - qname_list[r["read_id"]] = (r["assigned_type"], r["assigned_subtype"]) + qname_lookup = {} # qname --> (a_type, a_subtype) + with gzip.open(per_read_tsv, "rt") as per_read_f: + for row in DictReader(per_read_f, delimiter="\t"): + # pdb.set_trace() + if ( + wanted_types is None + or (not exclude_type and row["assigned_type"] in wanted_types) + or (exclude_type and row["assigned_type"] not in wanted_types) + ) and ( + wanted_subtypes is None + or ( + not exclude_subtype and (row["assigned_subtype"] in wanted_subtypes) + ) + or ( + exclude_subtype and (row["assigned_subtype"] not in wanted_subtypes) + ) + ): + qname_lookup[row["read_id"]] = ( + row["assigned_type"], + row["assigned_subtype"], + ) cur_count = 0 reader = pysam.AlignmentFile(in_bam, "rb", check_sq=False) writer = pysam.AlignmentFile(out_bam, "wb", header=reader.header) - for r in reader: - if r.qname in qname_list: - d = add_assigned_types_to_record(r, *qname_list[r.qname]) + for rec in reader: + if rec.qname in qname_lookup: + d = add_assigned_types_to_record(rec, *qname_lookup[rec.qname]) writer.write(pysam.AlignedSegment.from_dict(d, reader.header)) cur_count += 1 if max_count is not None and cur_count >= max_count: @@ -123,19 +132,20 @@ def iter_cigar_w_aligned_pair(rec, writer): return total_err, total_len -def read_annotation_file(annot_filename): - """Read the annotation.txt file into a dictionary. +def load_annotation_file(annot_filename): + """Parse the annotation.txt file into a dictionary. Example: - NAME=chr1;TYPE=host; - NAME=chr2;TYPE=host; - NAME=myVector;TYPE=vector;REGION=1795-6553; - NAME=myCapRep;TYPE=repcap;REGION=1895-5987; - NAME=myHelper;TYPE=helper; + NAME=chr1;TYPE=host; + NAME=chr2;TYPE=host; + NAME=myVector;TYPE=vector;REGION=1795-6553; + NAME=myCapRep;TYPE=repcap;REGION=1895-5987; + NAME=myHelper;TYPE=helper; :param annot_filename: Annotation file following the format indicated above. Only "vector" is required. Others optional. :return: + """ result = {} for line in open(annot_filename): @@ -144,23 +154,27 @@ def read_annotation_file(annot_filename): if m is None: raise RuntimeError( f"{stuff} is not a valid annotation line! Should follow format " - "`NAME=xxxx;TYPE=xxxx;REGION=xxxx;`. Abort!" + "`NAME=xxxx;TYPE=xxxx;REGION=xxxx;` or `NAME=xxxx;TYPE=xxxx;`. Abort!" ) seq_name = m.group(1) - ref_type = m.group(2) + ref_label = m.group(2) coord_region = ( None if m.group(3) is None else tuple(map(int, m.group(3).split("=")[1].split("-"))) ) - if ref_type in result: - raise RuntimeError(f"Annotation file has multiple {ref_type} types. Abort!") - if ref_type not in ANNOT_TYPE_PRIORITIES: + if ref_label in result: raise RuntimeError( - f"{ref_type} is not a valid type (host, repcap, vector, helper). Abort!" + f"Annotation file has multiple {ref_label} types. Abort!" + ) + if ref_label not in ANNOT_TYPE_PRIORITIES: + logging.info( + "Nonstandard reference label %s; the known labels are: %s", + ref_label, + ", ".join(ANNOT_TYPE_PRIORITIES.keys()), ) - result[seq_name] = {"type": ref_type, "region": coord_region} + result[seq_name] = {"label": ref_label, "region": coord_region} return result @@ -225,7 +239,7 @@ def is_on_target(r, target_start, target_end): return "vector+backbone" -def assign_read_type(r, annotation): +def assign_alignment_type(r, annotation): """Determine the read alignment type and subtype. :param read_dict: dict of {'supp', 'primary'} @@ -237,14 +251,15 @@ def assign_read_type(r, annotation): , , """ - read_type = annotation[r.reference_name]["type"] - if annotation[r.reference_name]["region"] is not None: - return read_type, is_on_target(r, *annotation[r.reference_name]["region"]) - else: - return read_type, "NA" + ref_label = annotation[r.reference_name]["label"] + ref_coords = annotation[r.reference_name]["region"] + target_overlap = is_on_target(r, *ref_coords) if ref_coords is not None else "NA" + return ref_label, target_overlap def process_alignment_bam( + sample_id, + vector_type, sorted_sam_filename, annotation, output_prefix, @@ -257,7 +272,8 @@ def process_alignment_bam( :param annotation: :param output_prefix: """ - SUMMARY_FIELDS = [ + ALIGNMENT_FIELDS = [ + "sample_unique_id", "read_id", "read_len", "is_mapped", @@ -265,30 +281,32 @@ def process_alignment_bam( "map_name", "map_start0", "map_end1", + "map_strand", "map_len", "map_iden", - "map_type", - "map_subtype", + "map_label", + "map_target_overlap", ] PER_READ_FIELDS = [ "read_id", - "read_len", "has_primary", "has_supp", "assigned_type", "assigned_subtype", "effective_count", + "reference_label", + "read_target_overlap", ] NONMATCH_FIELDS = ["read_id", "pos0", "type", "type_len"] - f_summary = open(output_prefix + ".summary.tsv", "w") - f_nonmatch = open(output_prefix + ".nonmatch_stat.tsv", "w") + f_alignments = open(output_prefix + ".alignments.tsv", "w") + f_nonmatch = open(output_prefix + ".nonmatch.tsv", "w") f_per_read = open(output_prefix + ".per_read.tsv", "w") - out_summary = DictWriter(f_summary, SUMMARY_FIELDS, delimiter="\t") + out_alignments = DictWriter(f_alignments, ALIGNMENT_FIELDS, delimiter="\t") out_nonmatch = DictWriter(f_nonmatch, NONMATCH_FIELDS, delimiter="\t") out_per_read = DictWriter(f_per_read, PER_READ_FIELDS, delimiter="\t") - out_summary.writeheader() + out_alignments.writeheader() out_nonmatch.writeheader() out_per_read.writeheader() @@ -319,9 +337,11 @@ def process_alignment_bam( break if cur_r.qname != records[-1].qname: process_alignment_records_for_a_read( + sample_id, + vector_type, records, annotation, - out_summary, + out_alignments, out_nonmatch, out_per_read, bam_writer, @@ -332,11 +352,19 @@ def process_alignment_bam( except StopIteration: # finished reading the SAM file break + # Finish processing the last records process_alignment_records_for_a_read( - records, annotation, out_summary, out_nonmatch, out_per_read, bam_writer + sample_id, + vector_type, + records, + annotation, + out_alignments, + out_nonmatch, + out_per_read, + bam_writer, ) bam_writer.close() - f_summary.close() + f_alignments.close() f_nonmatch.close() f_per_read.close() return f_per_read.name, output_prefix + ".tagged.bam" @@ -404,8 +432,21 @@ def add_assigned_types_to_record(r, a_type, a_subtype): return d +def pipe_union(s1: str, s2: str | None): + if s2 is None or s1 == s2: + return s1 + return f"{s1}|{s2}" + + def process_alignment_records_for_a_read( - records, annotation, out_summary, out_nonmatch, out_per_read, bam_writer + sample_id, + vector_type, + records, + annotation, + out_alignments, + out_nonmatch, + out_per_read, + bam_writer, ): """For each, find the most probable assignment. @@ -424,6 +465,7 @@ def process_alignment_records_for_a_read( ) info = { + "sample_unique_id": sample_id, "read_id": r.qname, "read_len": r.query_length, "is_mapped": "N" if r.is_unmapped else "Y", @@ -432,10 +474,11 @@ def process_alignment_records_for_a_read( "map_name": "NA", "map_start0": "NA", "map_end1": "NA", + "map_strand": "-" if r.is_reverse else "+", "map_len": "NA", "map_iden": "NA", - "map_type": "NA", - "map_subtype": "NA", + "map_label": "NA", + "map_target_overlap": "NA", } if r.is_unmapped: read_tally["primary"] = info @@ -453,13 +496,14 @@ def process_alignment_records_for_a_read( info["map_start0"] = r.reference_start info["map_end1"] = r.reference_end info["map_len"] = r.reference_end - r.reference_start + # ENH: skip these 2 lines if map_label != "vector" total_err, total_len = iter_cigar_w_aligned_pair(r, out_nonmatch) - info["map_iden"] = 1 - total_err * 1.0 / total_len + info["map_iden"] = format(1.0 - total_err / total_len, ".10f") - a_type, a_subtype = assign_read_type(r, annotation) - info["map_type"] = a_type - info["map_subtype"] = a_subtype - logging.debug("%s %s %s", r.qname, a_type, a_subtype) + a_ref_label, a_target_overlap = assign_alignment_type(r, annotation) + info["map_label"] = a_ref_label + info["map_target_overlap"] = a_target_overlap + logging.debug("%s %s %s", r.qname, a_ref_label, a_target_overlap) # pdb.set_trace() if r.is_supplementary: @@ -467,7 +511,11 @@ def process_alignment_records_for_a_read( else: assert read_tally["primary"] is None read_tally["primary"] = info - # out_summary.writerow(info) # not writing here -- writing later when we rule out non-compatible subs + # NB: will write primary/supp to `out_alignments` after ruling out non-compatible subs + + # ------------- + # Classify read + # ============= # summarize it per read, now that all relevant alignments have been processed prim = read_tally["primary"] @@ -485,158 +533,248 @@ def process_alignment_records_for_a_read( bam_writer.write( pysam.AlignedSegment.from_dict( add_assigned_types_to_record( - prim["rec"], prim["map_type"], prim["map_subtype"] + prim["rec"], prim["map_label"], prim["map_target_overlap"] ), prim["rec"].header, ) ) del prim["rec"] - out_summary.writerow(prim) + out_alignments.writerow(prim) if supp is not None: bam_writer.write( pysam.AlignedSegment.from_dict( add_assigned_types_to_record( - supp["rec"], supp["map_type"], supp["map_subtype"] + supp["rec"], supp["map_label"], supp["map_target_overlap"] ), supp["rec"].header, ) ) del supp["rec"] - out_summary.writerow(supp) + out_alignments.writerow(supp) - sum_info = { + read_info = { "read_id": prim["read_id"], - "read_len": prim["read_len"], "has_primary": prim["is_mapped"], "has_supp": "Y" if supp is not None else "N", "assigned_type": "NA", "assigned_subtype": "NA", "effective_count": 1, + "reference_label": prim["map_label"] + if prim["is_mapped"] == "Y" + else "(unmapped)", + "read_target_overlap": "NA", } - if sum_info["has_primary"] == "Y": - if prim["map_type"] == "vector": - if supp is None: # special case: primary only, maps to vector --> is ssAAV - # double check the special case where there was supp candidates but no companion - if len(supps) > 0: - sum_type = "unclassified" # might be a weird case ex: a read covers the region twice as on + strand - sum_subtype = prim["map_subtype"] - else: # never had any supp candidates, def ssAAV - sum_type = "ssAAV" - sum_subtype = prim["map_subtype"] - elif supp["map_type"] == "vector": - if supp_orientation == "+/-": - # special case, primary+ supp, maps to vector, --> is scAAV - sum_type = "scAAV" + if read_info["has_primary"] == "Y": + # Set reference_label to a known label, chimeric-(non)vector, or leave as "NA" or "unmapped" + OLD_CHIMERIC_LOGIC = False + if OLD_CHIMERIC_LOGIC: + reference_labels = [prim["map_label"]] + if supp is not None and supp["map_label"] != prim["map_label"]: + reference_labels.append(supp["map_label"]) + else: + reference_labels = [ + prim["map_label"], + *{s["map_label"] for s in supps if s["map_label"] != prim["map_label"]}, + ] + if len(reference_labels) == 1: + read_info["reference_label"] = reference_labels[0] + elif "vector" in reference_labels: + read_info["reference_label"] = "chimeric-vector" + else: + read_info["reference_label"] = "chimeric-nonvector" + + # Set read_target_overlap from primary and supplementary target_overlap (if any) + if supp is None: + read_target_overlap = prim["map_target_overlap"] + else: + read_target_overlap = pipe_union( + prim["map_target_overlap"], supp["map_target_overlap"] + ) + + # For vector reads, assigned type and subtype depending on context + # based on orientation, assigned_type, vector_type... + read_type, read_subtype = "NA", "NA" + if read_info["reference_label"] == "vector": + # Special cases, regardless of ss/scAAV + if read_target_overlap == "backbone": + read_type, read_subtype = "backbone", "backbone" + elif supp is None and len(supps) > 0: + # Primary and supplementary alignments diverge, instead of overlapping + read_type, read_subtype = "other-vector", "complex" + elif supp_orientation == "+/+": + # Supplementary alignment duplicates the primary in the same direction + read_type, read_subtype = "other-vector", "tandem" + + # ssAAV classification + elif vector_type == "ss": + if supp is None: + read_type = "ssAAV" + # Proper ssAAV subtypes + if read_target_overlap in ( + "full", + "full-gap", + "left-partial", + "right-partial", + "partial", + ): + read_subtype = read_target_overlap + elif read_target_overlap == "vector+backbone": + read_subtype = "read-through" + # TODO - distinguish "reverse-packaging" w/ ITR coordinates + else: + raise NotImplementedError( + f"Unrecognized {read_target_overlap=}" + ) else: - assert supp_orientation == "+/+" - sum_type = "tandem" - if supp["map_subtype"] == prim["map_subtype"]: - sum_subtype = prim["map_subtype"] + # Not-really-ssAAV subtypes + read_type = "other-vector" + assert ( + supp_orientation == "+/-" + ), f"Unrecognized {supp_orientation=}" + if read_target_overlap == "left-partial": + read_type, read_subtype = "ssAAV", "left-snapback" + elif read_target_overlap == "right-partial": + read_type, read_subtype = "ssAAV", "right-snapback" + elif read_target_overlap == "partial": + read_subtype = "snapback" + elif read_target_overlap in ("full", "full-gap"): + read_subtype = "unresolved-dimer" + elif "|" in read_target_overlap: + read_subtype = "complex" + else: + # E.g. vector+backbone + logging.warning( + "Unclassified non-ssAAV read-target overlap '%s':", + read_target_overlap, + ) + read_subtype = "unclassified" + + # scAAV classification + elif vector_type == "sc": + if supp_orientation == "+/-": + read_type = "scAAV" + # Proper scAAV subtypes + if read_target_overlap in ("full", "full-gap", "partial"): + read_subtype = read_target_overlap + elif read_target_overlap == "left-partial": + read_subtype = "snapback" + elif read_target_overlap == "right-partial": + # NB: Replication from mITR shouldn't happen -- special case + # Proposed term "direct-plasmid-packaged" + read_type, read_subtype = "other-vector", "unclassified" + elif read_target_overlap == "vector+backbone": + read_subtype = "read-through" + # TODO - distinguish "reverse-packaging" w/ ITR coordinates + elif "|" in read_target_overlap: + read_type, read_subtype = "other-vector", "complex" + else: + raise NotImplementedError( + f"Unrecognized {read_target_overlap=}" + ) + else: - sum_subtype = prim["map_subtype"] + "|" + supp["map_subtype"] - else: # primary is in vector, supp not in vector - sum_type = prim["map_type"] + "|" + supp["map_type"] - sum_subtype = prim["map_subtype"] + "|" + supp["map_subtype"] - # mapping to non-AAV vector region - elif supp is None: - sum_type = prim["map_type"] - sum_subtype = prim["map_subtype"] - elif supp["map_type"] == prim["map_type"]: - sum_type = prim["map_type"] - if supp["map_subtype"] == prim["map_subtype"]: - sum_subtype = prim["map_subtype"] + # Additional not-really-scAAV subtypes + read_type = "other-vector" + assert supp_orientation is None, f"Unrecognized {supp_orientation=}" + if read_target_overlap == "left-partial": + read_subtype = "itr-partial" + else: + read_subtype = "unclassified" + else: - sum_subtype = prim["map_subtype"] + "|" + supp["map_subtype"] - else: - sum_type = prim["map_type"] + "|" + supp["map_type"] - sum_subtype = prim["map_subtype"] + "|" + supp["map_subtype"] - sum_info["assigned_type"] = sum_type - sum_info["assigned_subtype"] = sum_subtype - - # ############################################################### - # 'effective_count' - now look at whether this is an ssAAV type - # ex: //ccs means potential two species (effective count of 2) - # ex: //ccs/fwd or rev is just one - # NOTE: this can still be undercounting becuz not considering thing that are not ssAAV - # ############################################################### - if sum_info["assigned_type"] == "ssAAV": - if sum_info["read_id"].endswith("/ccs"): - sum_info["effective_count"] = 2 - # elif sum_info['read_id'].endswith('/ccs/fwd') or sum_info['read_id'].endswith('/ccs/rev'): - # sum_info['effective_count'] = 1 # not needed, default is to 1 - - out_per_read.writerow(sum_info) - logging.debug("%s", sum_info) + raise NotImplementedError(f"Unimplemented vector_type: {vector_type}") + + read_info["read_target_overlap"] = read_target_overlap + read_info["assigned_type"] = read_type + read_info["assigned_subtype"] = read_subtype + + # Infer 'effective_count' from read names: + # * "//ccs" -- potentially two molecular species (effective count of 2) + # * "//ccs/fwd" or "/rev" -- just one (keep default effective count 1) + # NOTE: This fails to count some scAAV reads that also represent 2 species; these + # cannot be detected because the dumbell info is not included in the PacBio CCS or + # subread BAMs. But they are only a small fraction of the reads. + + if ( + read_info["has_primary"] == "Y" + and len(supps) == 0 + and read_info["read_id"].endswith("/ccs") + ): + read_info["effective_count"] = 2 + + out_per_read.writerow(read_info) + logging.debug("%s", read_info) # pdb.set_trace() def run_processing_parallel( - sorted_sam_filename, annotation, output_prefix, num_chunks=1 + sample_id, vector_type, sorted_sam_filename, annotation, output_prefix, num_chunks=1 ): reader = pysam.AlignmentFile(open(sorted_sam_filename), check_sq=False) + # Get all distinct read names, keeping input order readname_list = [next(reader).qname] - for r in reader: + n_alignments = -1 + for n_alignments, r in enumerate(reader): if r.qname != readname_list[-1]: readname_list.append(r.qname) + logging.info("Scanned %d alignments in %s", n_alignments + 1, sorted_sam_filename) total_num_reads = len(readname_list) chunk_size = (total_num_reads // num_chunks) + 1 logging.info( - f"Total {total_num_reads} reads, dividing into {num_chunks} " - f"chunks of size {chunk_size}..." + "Total %d reads, dividing into %d chunks of size %d...", + total_num_reads, + num_chunks, + chunk_size, ) pool = [] for i in range(num_chunks): + starting_readname = readname_list[i * chunk_size] + ending_readname = ( + None + if (i + 1) * chunk_size > total_num_reads + else readname_list[(i + 1) * chunk_size] + ) p = Process( target=process_alignment_bam, args=( + sample_id, + vector_type, sorted_sam_filename, annotation, output_prefix + "." + str(i + 1), - readname_list[i * chunk_size], - None - if (i + 1) * chunk_size > total_num_reads - else readname_list[(i + 1) * chunk_size], + starting_readname, + ending_readname, ), ) p.start() pool.append(p) logging.info("Going from %s to %s", i * chunk_size, (i + 1) * chunk_size) for i, p in enumerate(pool): - logging.debug(f"DEBUG: Waiting for {i}th pool to finish.") + logging.debug("DEBUG: Waiting for pool %d to finish.", i) p.join() - # Combine the data together for *.nonmatch_stat.tsv, *.per_read.tsv, *.summary.tsv + # Combine the data together for *.nonmatch.tsv, *.per_read.tsv, *.alignments.tsv # Closes over: output_prefix, num_chunks - def gather_text_chunks(suffix, compress=False): + def gather_text_chunks(suffix): logging.info("Combining chunk data... (*%s)", suffix) # Copy the first chunk over - if compress: - out_path = output_prefix + suffix + ".gz" - f_out = gzip.open(out_path, "wb") - else: - out_path = output_prefix + suffix - f_out = open(out_path, "w") + out_path = output_prefix + suffix + ".gz" + f_out = gzip.open(out_path, "wt") first_chunk = f"{output_prefix}.1{suffix}" chunk_paths = [first_chunk] with open(first_chunk) as f_in: - if compress: - for line in f_in: - f_out.write(line.encode()) - else: - shutil.copyfileobj(f_in, f_out) + for line in f_in: + f_out.write(line) # Copy the remaining chunks for i in range(1, num_chunks): chunk_path = f"{output_prefix}.{i+1}{suffix}" with open(chunk_path) as f_in: f_in.readline() # Skip the header - if compress: - for line in f_in: - f_out.write(line.encode()) - else: - shutil.copyfileobj(f_in, f_out) + for line in f_in: + f_out.write(line) chunk_paths.append(chunk_path) f_out.close() # Delete the chunk data @@ -645,11 +783,9 @@ def gather_text_chunks(suffix, compress=False): os.remove(chunk_path) return out_path - _outpath_nonmatch = gather_text_chunks( - ".nonmatch_stat.tsv", compress=True - ) # -> .nonmatch_stat.tsv.gz + _outpath_nonmatch = gather_text_chunks(".nonmatch.tsv") outpath_per_read = gather_text_chunks(".per_read.tsv") - _outpath_summary = gather_text_chunks(".summary.tsv") + _outpath_alignments = gather_text_chunks(".alignments.tsv") # Combine the data together for *.tagged.bam # TODO - samtools cat/merge? @@ -659,9 +795,7 @@ def gather_text_chunks(suffix, compress=False): bam_chunk_paths = [first_bam_chunk] bam_reader = pysam.AlignmentFile(first_bam_chunk, "rb", check_sq=False) outpath_bam = output_prefix + ".tagged.bam" - f_tagged_bam = pysam.AlignmentFile( - outpath_bam, "wb", template=bam_reader - ) + f_tagged_bam = pysam.AlignmentFile(outpath_bam, "wb", template=bam_reader) for r in bam_reader: f_tagged_bam.write(r) # Copy the remaining chunks @@ -682,65 +816,91 @@ def gather_text_chunks(suffix, compress=False): def main(args): """Entry point.""" - annotation = read_annotation_file(args.annotation_txt) + annotation = load_annotation_file(args.annotation_txt) if args.cpus == 1: per_read_tsv, full_out_bam = process_alignment_bam( - args.sam_filename, annotation, args.output_prefix + args.sample_id, + args.vector_type, + args.sam_filename, + annotation, + args.output_prefix, ) else: per_read_tsv, full_out_bam = run_processing_parallel( - args.sam_filename, annotation, args.output_prefix, num_chunks=args.cpus + args.sample_id, + args.vector_type, + args.sam_filename, + annotation, + args.output_prefix, + num_chunks=args.cpus, ) # subset BAM files into major categories for ease of loading into IGV for viewing # subset_sam_by_readname_list(in_bam, out_bam, per_read_tsv, wanted_types, wanted_subtypes) + subset_bam_prefixes = [] + if args.vector_type == "sc": + out_pfx = args.output_prefix + ".scAAV-full" + subset_bam_prefixes.append(out_pfx) + subset_sam_by_readname_list( + full_out_bam, + out_pfx + ".tagged.bam", + per_read_tsv, + ["scAAV"], + ["full"], + ) + out_pfx = args.output_prefix + ".scAAV-partials" + subset_bam_prefixes.append(out_pfx) + subset_sam_by_readname_list( + full_out_bam, + out_pfx + ".tagged.bam", + per_read_tsv, + ["scAAV"], + ["partial", "left-partial", "right-partial"], + ) + out_pfx = args.output_prefix + ".scAAV-other" + subset_bam_prefixes.append(out_pfx) + subset_sam_by_readname_list( + full_out_bam, + out_pfx + ".tagged.bam", + per_read_tsv, + ["scAAV"], + ["partial", "left-partial", "right-partial", "full"], + exclude_subtype=True, + ) + elif args.vector_type == "ss": + out_pfx = args.output_prefix + ".ssAAV-full" + subset_bam_prefixes.append(out_pfx) + subset_sam_by_readname_list( + full_out_bam, + out_pfx + ".tagged.bam", + per_read_tsv, + ["ssAAV"], + ["full"], + ) + out_pfx = args.output_prefix + ".ssAAV-partials" + subset_bam_prefixes.append(out_pfx) + subset_sam_by_readname_list( + full_out_bam, + out_pfx + ".tagged.bam", + per_read_tsv, + ["ssAAV"], + ["partial", "left-partial", "right-partial"], + ) + out_pfx = args.output_prefix + ".ssAAV-other" + subset_bam_prefixes.append(out_pfx) + subset_sam_by_readname_list( + full_out_bam, + out_pfx + ".tagged.bam", + per_read_tsv, + ["ssAAV"], + ["partial", "left-partial", "right-partial", "full"], + exclude_subtype=True, + ) + out_pfx = args.output_prefix + ".others" + subset_bam_prefixes.append(out_pfx) subset_sam_by_readname_list( full_out_bam, - args.output_prefix + ".scAAV-full.tagged.bam", - per_read_tsv, - ["scAAV"], - ["full"], - ) - subset_sam_by_readname_list( - full_out_bam, - args.output_prefix + ".scAAV-partials.tagged.bam", - per_read_tsv, - ["scAAV"], - ["partial", "left-partial", "right-partial"], - ) - subset_sam_by_readname_list( - full_out_bam, - args.output_prefix + ".scAAV-other.tagged.bam", - per_read_tsv, - ["scAAV"], - ["partial", "left-partial", "right-partial", "full"], - exclude_subtype=True, - ) - subset_sam_by_readname_list( - full_out_bam, - args.output_prefix + ".ssAAV-full.tagged.bam", - per_read_tsv, - ["ssAAV"], - ["full"], - ) - subset_sam_by_readname_list( - full_out_bam, - args.output_prefix + ".ssAAV-partials.tagged.bam", - per_read_tsv, - ["ssAAV"], - ["partial", "left-partial", "right-partial"], - ) - subset_sam_by_readname_list( - full_out_bam, - args.output_prefix + ".ssAAV-other.tagged.bam", - per_read_tsv, - ["ssAAV"], - ["partial", "left-partial", "right-partial", "full"], - exclude_subtype=True, - ) - subset_sam_by_readname_list( - full_out_bam, - args.output_prefix + ".others.tagged.bam", + out_pfx + ".tagged.bam", per_read_tsv, ["ssAAV", "scAAV"], None, @@ -756,17 +916,7 @@ def main(args): ) sys.exit(-1) - parts = [ - ".scAAV-full", - ".scAAV-partials", - ".scAAV-other", - ".ssAAV-full", - ".ssAAV-partials", - ".ssAAV-other", - ".others", - ] - for part in parts: - p = args.output_prefix + part + for p in subset_bam_prefixes: subprocess.check_call( f"samtools sort {p}.tagged.bam > {p}.tagged.sorted.bam", shell=True ) @@ -780,6 +930,13 @@ def main(args): parser.add_argument("sam_filename", help="Sorted by read name SAM file") parser.add_argument("annotation_txt", help="Annotation file") parser.add_argument("output_prefix", help="Output prefix") + parser.add_argument("-i", "--sample-id", required=True, help="Sample unique ID") + parser.add_argument( + "--vector-type", + choices=["sc", "ss", "unspecified"], + default="unspecified", + help="Vector type; one of: sc, ss, unspecified", + ) parser.add_argument( "--max-allowed-missing-flanking", default=100, diff --git a/src/write_sample_metadata.py b/src/write_sample_metadata.py index a8e1a78..fd55c26 100755 --- a/src/write_sample_metadata.py +++ b/src/write_sample_metadata.py @@ -1,6 +1,8 @@ #!/usr/bin/env python3 """Write sample ID, name, and sequencing run ID as a 2-line TSV.""" +from __future__ import annotations + import argparse import csv from pathlib import Path @@ -23,7 +25,7 @@ def seq_run_id_from_bam(bam_fname): AP.add_argument("-o", "--output", required=True, help="*.tsv") args = AP.parse_args() - with Path.open(args.output, "w") as out_handle: + with Path(args.output).open("w") as out_handle: cw = csv.writer(out_handle, delimiter="\t") cw.writerow(["sample_unique_id", "sample_display_name", "sequencing_run_id"]) cw.writerow( diff --git a/test/Makefile b/test/Makefile index 361481e..48e1083 100644 --- a/test/Makefile +++ b/test/Makefile @@ -1,10 +1,10 @@ -# Local tests: Run the core analysis steps on downsampled copies of the public PacBio scAAV data +# Local tests: Run the core analysis steps on downsampled copies of the public PacBio example data in_dir = samples out_dir = build NCPU = 4 -.PHONY: all sc ss clean +.PHONY: all clean sc ss test all: sc ss clean: @@ -14,34 +14,35 @@ sc: $(out_dir)/sc_AAV_report.html ss: $(out_dir)/ss_AAV_report.html +test: sc ss + pytest test_outputs.py -diffcheck: - diff build-snapshot/sc.per_read.tsv build/sc.per_read.tsv && echo "OK" - diff build-snapshot/ss.per_read.tsv build/ss.per_read.tsv && echo "OK" - diff build-snapshot/ss.flipflop.tsv build/ss.flipflop.tsv && echo "OK" -$(out_dir)/sc_AAV_report.html $(out_dir)/ss_AAV_report.html: \ - %_AAV_report.html: \ - ../src/create_report.R %.Rdata - $^ +$(out_dir)/sc_AAV_report.html: ../src/create_report.R ../src/report.Rmd $(out_dir)/sc.annotation.txt $(out_dir)/sc.metadata.tsv $(out_dir)/sc.tagged.bam + $< $(out_dir)/sc sc $(word 3,$^) +$(out_dir)/ss_AAV_report.html: ../src/create_report.R ../src/report.Rmd $(out_dir)/ss.annotation.txt $(out_dir)/ss.metadata.tsv $(out_dir)/ss.flipflop.tsv.gz + $< $(out_dir)/ss ss $(word 3,$^) -$(out_dir)/sc.Rdata: ../src/calculate_rdata.R ../src/report.Rmd $(out_dir)/sc.annotation.txt $(out_dir)/sc.tagged.bam - $< $(out_dir)/sc $(out_dir)/sc.annotation.txt pAV-CMV-GFP "scaav" -$(out_dir)/ss.Rdata: ../src/calculate_rdata.R ../src/report.Rmd $(out_dir)/ss.annotation.txt $(out_dir)/ss.flipflop_assignments.tsv $(out_dir)/ss.tagged.bam - $< $(out_dir)/ss $(out_dir)/ss.annotation.txt pAV-CMV-GFP "ssaav" $(out_dir)/ss.flipflop_assignments.tsv +$(out_dir)/sc.metadata.tsv: ../src/write_sample_metadata.py $(in_dir)/sc.subsample005.bam + mkdir -p $(out_dir) + $< sc.subsample005 "Self-comp Example" $(word 2,$^) -o $@ +$(out_dir)/ss.metadata.tsv: ../src/write_sample_metadata.py $(in_dir)/ss.subsample005.bam + mkdir -p $(out_dir) + $< ss.subsample005 "Single-stranded Example" $(word 2,$^) -o $@ -$(out_dir)/ss.flipflop_assignments.tsv: ../src/get_flipflop_config.py $(out_dir)/ss.tagged.bam $(out_dir)/ss.per_read.tsv + +$(out_dir)/ss.flipflop.tsv.gz: ../src/get_flipflop_config.py $(out_dir)/ss.tagged.bam $(out_dir)/ss.per_read.tsv.gz $^ -o $(out_dir)/ss -$(out_dir)/sc.tagged.bam: ../src/summarize_AAV_alignment.py $(in_dir)/sc.subsample005.bam $(out_dir)/sc.annotation.txt - $^ $(out_dir)/sc --cpus $(NCPU) +$(out_dir)/sc.tagged.bam: ../src/summarize_alignment.py $(in_dir)/sc.subsample005.bam $(out_dir)/sc.annotation.txt + $^ $(out_dir)/sc --sample-id sc.subsample005 --vector-type sc --cpus $(NCPU) -$(out_dir)/ss.tagged.bam: ../src/summarize_AAV_alignment.py $(in_dir)/ss.subsample005.bam $(out_dir)/ss.annotation.txt - $^ $(out_dir)/ss --cpus $(NCPU) +$(out_dir)/ss.tagged.bam: ../src/summarize_alignment.py $(in_dir)/ss.subsample005.bam $(out_dir)/ss.annotation.txt + $^ $(out_dir)/ss --sample-id ss.subsample005 --vector-type ss --cpus $(NCPU) $(out_dir)/sc.annotation.txt: ../src/prepare_annotation.py $(in_dir)/sc.annotation.bed $(out_dir)/sc.reference_names.tsv @@ -54,6 +55,7 @@ $(out_dir)/ss.annotation.txt: ../src/prepare_annotation.py $(in_dir)/ss.annotati $(out_dir)/sc.reference_names.tsv $(out_dir)/ss.reference_names.tsv: \ $(out_dir)/%.reference_names.tsv: \ samples/%.construct.fasta fasta/packaging.fa fasta/hg38.chr19trunc-chrM.fa + mkdir -p $(out_dir) ../src/get_reference_names.py -o $@ \ $< --packaging $(word 2,$^) --host $(word 3,$^) \ --repcap-name pRep2Cap9 --helper-name pHelper --lambda-name Lambda diff --git a/test/build-snapshot/sc.per_read.tsv b/test/build-snapshot/sc.per_read.tsv deleted file mode 100644 index 9dcac6a..0000000 --- a/test/build-snapshot/sc.per_read.tsv +++ /dev/null @@ -1,1688 +0,0 @@ -read_id read_len has_primary has_supp assigned_type assigned_subtype effective_count -m54119U_210730_213233/1728/ccs 4091 Y Y scAAV full 1 -m54119U_210730_213233/65803/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/131613/ccs/fwd 4080 Y Y scAAV full 1 -m54119U_210730_213233/263794/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/328379/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/393800/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/461400/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/524757/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/591943/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/658139/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/854370/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/919777/ccs 4160 Y Y scAAV full 1 -m54119U_210730_213233/1051031/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/1116950/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/1180354/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/1182470/ccs 4079 Y Y scAAV full 1 -m54119U_210730_213233/1313390/ccs 3314 Y Y scAAV left-partial 1 -m54119U_210730_213233/1377880/ccs/fwd 1307 Y N ssAAV right-partial 1 -m54119U_210730_213233/1507934/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/1508607/ccs/rev 4050 Y Y scAAV full 1 -m54119U_210730_213233/1639754/ccs/rev 4024 Y Y scAAV full 1 -m54119U_210730_213233/1772187/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/1835008/ccs/fwd 4062 Y Y scAAV full 1 -m54119U_210730_213233/2033555/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/2097577/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/2361610/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/2425053/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/2491752/ccs 3991 Y Y scAAV full 1 -m54119U_210730_213233/2493054/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/2556860/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/2623067/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/2884309/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/3081442/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/3148488/ccs/fwd 4087 Y Y scAAV full 1 -m54119U_210730_213233/3343570/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/3409991/ccs/fwd 3995 Y Y scAAV full 1 -m54119U_210730_213233/3473775/ccs/fwd 4075 Y Y scAAV full 1 -m54119U_210730_213233/3670767/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/3672756/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/3736578/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/3802664/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/3932533/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/3933331/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/3998623/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/4064567/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/4130671/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/4327535/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/4523877/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/4589184/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/4653831/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/4915351/ccs 4080 Y Y scAAV full 1 -m54119U_210730_213233/4981024/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/5113156/ccs/rev 4053 Y Y scAAV full 1 -m54119U_210730_213233/5375563/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/5376742/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/5571221/ccs 4038 Y Y scAAV full 1 -m54119U_210730_213233/5571446/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/5636735/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/5637948/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/5965607/ccs 4036 Y Y scAAV full 1 -m54119U_210730_213233/6031511/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/6095223/ccs/fwd 4063 Y Y scAAV full 1 -m54119U_210730_213233/6097647/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/6357688/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/6359417/ccs/fwd 4062 Y Y scAAV full 1 -m54119U_210730_213233/6425050/ccs 4044 Y Y scAAV full 1 -m54119U_210730_213233/6490840/ccs/rev 4102 Y Y scAAV full 1 -m54119U_210730_213233/6817946/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/6881849/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/7275884/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/7276181/ccs/fwd 4060 Y Y scAAV full 1 -m54119U_210730_213233/7277286/ccs 4084 Y Y scAAV full 1 -m54119U_210730_213233/7472268/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/7604210/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/7604850/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/7733791/ccs/fwd 4050 Y Y scAAV full 1 -m54119U_210730_213233/7734449/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/7930100/ccs 4078 Y Y scAAV full 1 -m54119U_210730_213233/7997005/ccs/fwd 4075 Y Y scAAV full 1 -m54119U_210730_213233/8258441/ccs/rev 4073 Y Y scAAV full 1 -m54119U_210730_213233/8259715/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/8259944/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/8522432/ccs 4047 Y Y scAAV full 1 -m54119U_210730_213233/8585980/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/8587918/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/8718097/ccs 2851 Y Y scAAV backbone 1 -m54119U_210730_213233/8913351/ccs 3963 Y Y scAAV full 1 -m54119U_210730_213233/8915611/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/9241322/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/9241415/ccs/fwd 4057 Y Y scAAV full 1 -m54119U_210730_213233/9307459/ccs/rev 4073 Y Y scAAV full 1 -m54119U_210730_213233/9307539/ccs/fwd 2050 Y N ssAAV full 1 -m54119U_210730_213233/9307802/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/9373622/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/9504230/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/9636286/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/9636320/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/9833297/ccs 4034 Y Y scAAV full 1 -m54119U_210730_213233/9963171/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/10027227/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/10094819/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/10225884/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/10421776/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/10422353/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/10553718/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/10945363/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/11075772/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/11206732/ccs 4089 Y Y scAAV full 1 -m54119U_210730_213233/11273161/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/11602295/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/12125491/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/12190381/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/12256243/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/12323175/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/12716344/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/13043613/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/13107474/ccs 4134 Y Y scAAV full 1 -m54119U_210730_213233/13109474/ccs 4086 Y Y scAAV full 1 -m54119U_210730_213233/13371940/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/13501308/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/13631639/ccs 3033 Y Y tandem vector+backbone|left-partial 1 -m54119U_210730_213233/13699124/ccs 3981 Y Y scAAV full 1 -m54119U_210730_213233/13893912/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/13959192/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/14091521/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/14155983/ccs/fwd 3950 Y Y scAAV full 1 -m54119U_210730_213233/14221446/ccs/fwd 1714 Y N ssAAV right-partial 1 -m54119U_210730_213233/14288856/ccs/fwd 4080 Y Y scAAV full 1 -m54119U_210730_213233/14354184/ccs/fwd 4007 Y Y scAAV full 1 -m54119U_210730_213233/14551141/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/14615036/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/14747407/ccs/rev 4091 Y Y scAAV full 1 -m54119U_210730_213233/14942721/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/15007845/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/15008545/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/15009762/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/15206411/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/15600129/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/16057584/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/16187484/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/16190111/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/16254632/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/16516325/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/16973911/ccs/rev 4052 Y Y scAAV full 1 -m54119U_210730_213233/16976148/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/17041604/ccs/rev 4095 Y Y scAAV full 1 -m54119U_210730_213233/17107806/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/17238649/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/17433196/ccs/rev 4059 Y Y scAAV full 1 -m54119U_210730_213233/17631600/ccs/fwd 4058 Y Y scAAV full 1 -m54119U_210730_213233/17695045/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/17761121/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/17762060/ccs 4022 Y Y scAAV full 1 -m54119U_210730_213233/17893122/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/17958125/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/18022765/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/18153871/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/18482659/ccs 2056 Y Y tandem full|right-partial 1 -m54119U_210730_213233/18547969/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/18548051/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/18549568/ccs/rev 4082 Y Y scAAV full 1 -m54119U_210730_213233/18874718/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/18940102/ccs/rev 4060 Y Y scAAV full 1 -m54119U_210730_213233/18942598/ccs/fwd 2859 Y Y scAAV vector+backbone 1 -m54119U_210730_213233/19006018/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/19071824/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/19268221/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/19268873/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/19335834/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/19398743/ccs 3999 Y Y scAAV full 1 -m54119U_210730_213233/19399920/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/19465513/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/19466272/ccs/rev 4055 Y Y scAAV full 1 -m54119U_210730_213233/19531050/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/19596474/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/19662943/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/19663378/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/19726414/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/19728732/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/19792246/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/19792982/ccs 3675 Y Y scAAV right-partial 1 -m54119U_210730_213233/19859119/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/19923674/ccs 4128 Y Y scAAV full 1 -m54119U_210730_213233/20579035/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/20645217/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/20775974/ccs/rev 4055 Y Y scAAV full 1 -m54119U_210730_213233/20840742/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/20841793/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/20972589/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/21037281/ccs/fwd 4090 Y Y scAAV full 1 -m54119U_210730_213233/21038775/ccs/fwd 4048 Y Y scAAV full 1 -m54119U_210730_213233/21104964/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/21366608/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/21432733/ccs/rev 4059 Y Y scAAV full 1 -m54119U_210730_213233/21497012/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/21561440/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/21561666/ccs 4046 Y Y scAAV full 1 -m54119U_210730_213233/21955031/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/21955185/ccs/rev 4057 Y Y scAAV full 1 -m54119U_210730_213233/21955570/ccs 4048 Y Y scAAV full 1 -m54119U_210730_213233/22349529/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/22413387/ccs 4029 Y Y scAAV full 1 -m54119U_210730_213233/22741223/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/22742199/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/22808865/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/22937985/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/23200771/ccs 4047 Y Y scAAV full 1 -m54119U_210730_213233/23397942/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/23528025/ccs/fwd 4076 Y Y scAAV full 1 -m54119U_210730_213233/23593929/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/23594923/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/24249835/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/24250280/ccs/rev 4087 Y Y scAAV full 1 -m54119U_210730_213233/24381776/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/24643197/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/24709124/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/24772948/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/24773583/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/24774197/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/24970626/ccs 4083 Y Y scAAV full 1 -m54119U_210730_213233/24971204/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/25232332/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/25560725/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/25626680/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/25690254/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/25889611/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/26019441/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/26083775/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/26216748/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/26217128/ccs/fwd 4045 Y Y scAAV full 1 -m54119U_210730_213233/26281040/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/26477994/ccs/rev 4074 Y Y scAAV full 1 -m54119U_210730_213233/26610406/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/26870072/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/26936420/ccs 4050 Y Y scAAV full 1 -m54119U_210730_213233/27001312/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/27003202/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/27003534/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/27066428/ccs/rev 4059 Y Y scAAV full 1 -m54119U_210730_213233/27265608/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/27329901/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/27331171/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/27396454/ccs 4048 Y Y scAAV full 1 -m54119U_210730_213233/27658750/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/27853294/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/27853992/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/27854413/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/27984424/ccs 4079 Y Y scAAV full 1 -m54119U_210730_213233/28182628/ccs 4082 Y Y scAAV full 1 -m54119U_210730_213233/28312435/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/29163734/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/29164142/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/29557316/ccs/rev 4081 Y Y scAAV full 1 -m54119U_210730_213233/29754398/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/30474447/ccs/rev 4056 Y Y scAAV full 1 -m54119U_210730_213233/30477000/ccs/fwd 4061 Y Y scAAV full 1 -m54119U_210730_213233/30606256/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/30670881/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/30672909/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/30998708/ccs/rev 4053 Y Y scAAV full 1 -m54119U_210730_213233/31131348/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/31196472/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/31196818/ccs 4090 Y Y scAAV full 1 -m54119U_210730_213233/31393389/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/31460131/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/31523904/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/31589124/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/31720552/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/31722128/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/31785222/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/31982169/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/31983170/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/32375556/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/32375945/ccs 2061 Y N ssAAV full 2 -m54119U_210730_213233/32443153/ccs 4041 Y Y scAAV full 1 -m54119U_210730_213233/32506836/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/32572649/ccs 4112 Y Y scAAV full 1 -m54119U_210730_213233/32637822/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/33030936/ccs 4101 Y Y scAAV full 1 -m54119U_210730_213233/33163211/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/33489674/ccs/rev 4076 Y Y scAAV full 1 -m54119U_210730_213233/33619974/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/33620060/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/33686857/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/33949856/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/34146494/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/34474708/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/34932918/ccs 4090 Y Y scAAV full 1 -m54119U_210730_213233/35129152/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/35195629/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/35391827/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/35520911/ccs/fwd 4061 Y Y scAAV full 1 -m54119U_210730_213233/35521226/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/35522122/ccs/fwd 4087 Y Y scAAV full 1 -m54119U_210730_213233/35523057/ccs/rev 4082 Y Y scAAV full 1 -m54119U_210730_213233/35588230/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/35718498/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/35915606/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/35980197/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/36046241/ccs/fwd 4060 Y Y scAAV full 1 -m54119U_210730_213233/36372789/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/36636690/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/36766187/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/36768394/ccs/fwd 4077 Y Y scAAV full 1 -m54119U_210730_213233/36963523/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/37095606/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/37160052/ccs/rev 4047 Y Y scAAV full 1 -m54119U_210730_213233/37161116/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/37161159/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/37356201/ccs/rev 4099 Y Y scAAV full 1 -m54119U_210730_213233/37356239/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/37552847/ccs 4037 Y Y scAAV full 1 -m54119U_210730_213233/37618351/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/37620322/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/37620406/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/37750624/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/37814681/ccs 3683 Y Y scAAV right-partial 1 -m54119U_210730_213233/37946591/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/37947940/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/37948130/ccs 4033 Y Y scAAV full 1 -m54119U_210730_213233/38012570/ccs 4078 Y Y scAAV full 1 -m54119U_210730_213233/38208325/ccs 4051 Y Y scAAV full 1 -m54119U_210730_213233/38405157/ccs/rev 4028 Y Y scAAV full 1 -m54119U_210730_213233/38666758/ccs/fwd 4077 Y Y scAAV full 1 -m54119U_210730_213233/38798581/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/38864483/ccs/fwd 4064 Y Y scAAV full 1 -m54119U_210730_213233/38928468/ccs/fwd 4062 Y Y scAAV full 1 -m54119U_210730_213233/39192938/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/39257153/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/39323743/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/39324010/ccs/rev 4075 Y Y scAAV full 1 -m54119U_210730_213233/39389770/ccs 1932 Y N unclassified right-partial 1 -m54119U_210730_213233/39389936/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/39649636/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/39650954/ccs/rev 4044 Y Y scAAV full 1 -m54119U_210730_213233/39717045/ccs 2068 Y N ssAAV full 2 -m54119U_210730_213233/39847910/ccs 4051 Y Y scAAV full 1 -m54119U_210730_213233/39911649/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/40109566/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/40239433/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/40241235/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/40241634/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/40438438/ccs/fwd 4085 Y Y scAAV full 1 -m54119U_210730_213233/40566925/ccs/fwd 4061 Y Y scAAV full 1 -m54119U_210730_213233/40698083/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/40698329/ccs/fwd 2628 Y Y scAAV right-partial 1 -m54119U_210730_213233/40961737/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/40961963/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/40962757/ccs/rev 4045 Y Y scAAV full 1 -m54119U_210730_213233/41223085/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/41223994/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/41224424/ccs 4090 Y Y scAAV full 1 -m54119U_210730_213233/41290190/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/41420566/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/41681598/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/41682833/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/41880410/ccs/fwd 4064 Y Y scAAV full 1 -m54119U_210730_213233/42010906/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/42075957/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/42205433/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/42271651/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/42404596/ccs 4096 Y Y scAAV full 1 -m54119U_210730_213233/42470051/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/42731740/ccs/fwd 4106 Y Y scAAV full 1 -m54119U_210730_213233/42797201/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/42927113/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/43057388/ccs/fwd 4036 Y Y scAAV full 1 -m54119U_210730_213233/43190337/ccs 2057 Y N ssAAV full 2 -m54119U_210730_213233/43320708/ccs 4049 Y Y scAAV full 1 -m54119U_210730_213233/43386098/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/43451379/ccs/rev 4060 Y Y scAAV full 1 -m54119U_210730_213233/43452202/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/43516786/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/43647242/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/43846016/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/43911156/ccs/fwd 1405 Y Y scAAV left-partial 1 -m54119U_210730_213233/43975075/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/43975926/ccs/rev 4062 Y Y scAAV full 1 -m54119U_210730_213233/44040882/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/44041558/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/44172442/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/44172583/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/44303317/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/44368831/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/44435102/ccs 4047 Y Y scAAV full 1 -m54119U_210730_213233/44761866/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/44827794/ccs/rev 4048 Y Y scAAV full 1 -m54119U_210730_213233/44828121/ccs/fwd 4052 Y Y scAAV full 1 -m54119U_210730_213233/44959522/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/44960170/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/44960383/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/45285547/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/45482384/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/45549600/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/45681415/ccs 4041 Y Y scAAV full 1 -m54119U_210730_213233/45745876/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/45941523/ccs/fwd 4064 Y Y scAAV full 1 -m54119U_210730_213233/46336251/ccs/fwd 4087 Y Y scAAV full 1 -m54119U_210730_213233/46402214/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/46597324/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/46597642/ccs 3976 Y Y scAAV full 1 -m54119U_210730_213233/46598255/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/46598851/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/46792862/ccs/fwd 4081 Y Y scAAV full 1 -m54119U_210730_213233/46794644/ccs 3128 N N NA NA 1 -m54119U_210730_213233/46990346/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/46991276/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/46991702/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/47253983/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/47254130/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/47383099/ccs 2060 Y N ssAAV full 2 -m54119U_210730_213233/47581610/ccs/fwd 3245 Y Y scAAV right-partial 1 -m54119U_210730_213233/47646231/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/47712179/ccs/rev 4060 Y Y scAAV full 1 -m54119U_210730_213233/47712447/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/47712862/ccs 4081 Y Y scAAV full 1 -m54119U_210730_213233/47775929/ccs/rev 4047 Y Y scAAV full 1 -m54119U_210730_213233/47908033/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/48039014/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/48302657/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/48302707/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/48302866/ccs 3223 Y Y scAAV right-partial 1 -m54119U_210730_213233/48366202/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/48759576/ccs/rev 4059 Y Y scAAV full 1 -m54119U_210730_213233/48826547/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/48958102/ccs 3664 Y Y scAAV right-partial 1 -m54119U_210730_213233/49086924/ccs 4029 Y Y scAAV full 1 -m54119U_210730_213233/49089198/ccs/rev 3500 Y Y scAAV right-partial 1 -m54119U_210730_213233/49349919/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/49414706/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/49546358/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/49547730/ccs 1978 Y N ssAAV right-partial 2 -m54119U_210730_213233/49611510/ccs/rev 4060 Y Y scAAV full 1 -m54119U_210730_213233/49677297/ccs 189 Y N ssAAV right-partial 2 -m54119U_210730_213233/49808635/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/49939288/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/49939288/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/50006005/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/50203281/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/50398498/ccs 4036 Y Y scAAV full 1 -m54119U_210730_213233/50660686/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/50661565/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/50661872/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/50727757/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/50858001/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/51184092/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/51250324/ccs/rev 2386 Y Y scAAV right-partial 1 -m54119U_210730_213233/51708301/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/51710053/ccs/rev 3160 Y Y scAAV right-partial 1 -m54119U_210730_213233/51972499/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/52167194/ccs/rev 4073 Y Y scAAV full 1 -m54119U_210730_213233/52300153/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/52364806/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/52428991/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/52429070/ccs/rev 4062 Y Y scAAV full 1 -m54119U_210730_213233/52560743/ccs 3804 Y Y scAAV left-partial 1 -m54119U_210730_213233/52628271/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/52824241/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/52889649/ccs 3680 Y Y scAAV right-partial 1 -m54119U_210730_213233/52953343/ccs 4096 Y Y scAAV full 1 -m54119U_210730_213233/52955140/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/52955983/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/53019954/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/53084652/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/53085587/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/53283233/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/53675896/ccs/fwd 4032 Y Y scAAV full 1 -m54119U_210730_213233/53676802/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/53805193/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/53870691/ccs 4080 Y Y scAAV full 1 -m54119U_210730_213233/54003352/ccs/fwd 4076 Y Y scAAV full 1 -m54119U_210730_213233/54067386/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/54067644/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/54266136/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/54329984/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/54854459/ccs/fwd 3974 Y Y scAAV full 1 -m54119U_210730_213233/55050507/ccs/rev 3991 Y Y scAAV full 1 -m54119U_210730_213233/55183152/ccs/rev 4090 Y Y scAAV full 1 -m54119U_210730_213233/55183400/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/55183848/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/55380214/ccs 4079 Y Y scAAV full 1 -m54119U_210730_213233/55445050/ccs/fwd 3155 Y Y scAAV right-partial 1 -m54119U_210730_213233/55511083/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/55511453/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/55705706/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/55839268/ccs 2063 Y Y tandem full|right-partial 1 -m54119U_210730_213233/55969146/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/56034367/ccs/fwd 4081 Y Y scAAV full 1 -m54119U_210730_213233/56034892/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/56035788/ccs/fwd 4288 Y Y scAAV full 1 -m54119U_210730_213233/56166787/ccs 4053 Y Y scAAV full 1 -m54119U_210730_213233/56230370/ccs 4132 Y Y scAAV full 1 -m54119U_210730_213233/56362991/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/56428826/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/56623481/ccs 4084 Y Y scAAV full 1 -m54119U_210730_213233/56689015/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/56690342/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/56690575/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/56690656/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/56756824/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/56821993/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/56885623/ccs/fwd 4062 Y Y scAAV full 1 -m54119U_210730_213233/56950918/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/56953675/ccs 4042 Y Y scAAV full 1 -m54119U_210730_213233/57018293/ccs 2710 Y Y scAAV right-partial 1 -m54119U_210730_213233/57083441/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/57279186/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/57344751/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/57345129/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/57345694/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/57345721/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/57411100/ccs 4089 Y Y scAAV full 1 -m54119U_210730_213233/57804377/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/57870955/ccs 3963 Y Y scAAV full 1 -m54119U_210730_213233/58001764/ccs/rev 4554 Y Y scAAV full 1 -m54119U_210730_213233/58066986/ccs/fwd 4089 Y Y scAAV full 1 -m54119U_210730_213233/58197787/ccs/fwd 4075 Y Y scAAV full 1 -m54119U_210730_213233/58328157/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/58392835/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/58524023/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/58655237/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/58721944/ccs/rev 4075 Y Y scAAV full 1 -m54119U_210730_213233/58853940/ccs/fwd 4056 Y Y scAAV full 1 -m54119U_210730_213233/59116186/ccs 2008 Y Y scAAV right-partial 1 -m54119U_210730_213233/59180661/ccs 4041 Y Y scAAV full 1 -m54119U_210730_213233/59376370/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/59377982/ccs 4087 Y Y scAAV full 1 -m54119U_210730_213233/59507441/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/59507823/ccs 4080 Y Y scAAV full 1 -m54119U_210730_213233/59572352/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/59639282/ccs/rev 4056 Y Y scAAV full 1 -m54119U_210730_213233/60033169/ccs 4083 Y Y scAAV full 1 -m54119U_210730_213233/60163553/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/60294134/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/60492341/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/60622155/ccs 4081 Y Y scAAV full 1 -m54119U_210730_213233/60817644/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/60820219/ccs/fwd 4096 Y Y scAAV full 1 -m54119U_210730_213233/61015089/ccs 4110 Y Y scAAV full 1 -m54119U_210730_213233/61080357/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/61343149/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/61606513/ccs/fwd 4081 Y Y scAAV full 1 -m54119U_210730_213233/61932371/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/61933276/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/61998478/ccs/rev 4058 Y Y scAAV full 1 -m54119U_210730_213233/62128495/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/62130794/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/62193704/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/62194461/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/62326027/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/62589130/ccs 1729 Y N ssAAV right-partial 2 -m54119U_210730_213233/62720535/ccs 4050 Y Y scAAV full 1 -m54119U_210730_213233/62916050/ccs 4161 Y Y scAAV full 1 -m54119U_210730_213233/62980497/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/62982887/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/63111463/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/63177837/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/63178757/ccs 4032 Y Y scAAV full 1 -m54119U_210730_213233/63309442/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/63374383/ccs/fwd 4061 Y Y scAAV full 1 -m54119U_210730_213233/63638026/ccs/fwd 4064 Y Y scAAV full 1 -m54119U_210730_213233/63768532/ccs 4082 Y Y scAAV full 1 -m54119U_210730_213233/63834867/ccs 4101 Y Y scAAV full 1 -m54119U_210730_213233/63964037/ccs 1940 Y N ssAAV right-partial 2 -m54119U_210730_213233/64356827/ccs 4053 Y Y scAAV full 1 -m54119U_210730_213233/64553789/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/64554721/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/64619210/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/64621297/ccs 4048 Y Y scAAV full 1 -m54119U_210730_213233/64749905/ccs 4044 Y Y scAAV full 1 -m54119U_210730_213233/64817885/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/64880777/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/64883486/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/65144038/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/65209462/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/65536589/ccs/fwd 4050 Y Y scAAV full 1 -m54119U_210730_213233/65667987/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/65733632/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/65866018/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/66191700/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/66257300/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/66257936/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/66389200/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/66519333/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/66521442/ccs/rev 4059 Y Y scAAV full 1 -m54119U_210730_213233/66650385/ccs 3708 Y Y scAAV right-partial 1 -m54119U_210730_213233/66848982/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/67044787/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/67045154/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/67111619/ccs 3981 Y Y scAAV full 1 -m54119U_210730_213233/67174878/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/67242252/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/67308361/ccs/rev 4035 Y Y scAAV full 1 -m54119U_210730_213233/67570384/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/67633743/ccs/rev 4048 Y Y scAAV full 1 -m54119U_210730_213233/67699719/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/67830879/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/67961107/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/67961246/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/68027538/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/68027571/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/68158433/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/68355503/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/68355936/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/68422203/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/68681835/ccs 4047 Y Y scAAV full 1 -m54119U_210730_213233/68944418/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/69077699/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/69273450/ccs/rev 4073 Y Y scAAV full 1 -m54119U_210730_213233/69273736/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/69339143/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/69468888/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/69600875/ccs 4114 Y Y scAAV full 1 -m54119U_210730_213233/69667295/ccs 4094 Y Y scAAV full 1 -m54119U_210730_213233/69862783/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/69995066/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/70189882/ccs 4018 Y Y scAAV full 1 -m54119U_210730_213233/70190790/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/70191690/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/70256268/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/70322507/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/70519202/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/70583657/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/70648666/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/70649149/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/70650218/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/70714940/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/70715041/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/70780066/ccs/rev 4097 Y Y scAAV full 1 -m54119U_210730_213233/70780791/ccs/rev 4047 Y Y scAAV full 1 -m54119U_210730_213233/70911306/ccs/rev 4044 Y Y scAAV full 1 -m54119U_210730_213233/71043017/ccs 4112 Y Y scAAV full 1 -m54119U_210730_213233/71106908/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/71631283/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/72222619/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/72223389/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/72286638/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/72286716/ccs/rev 4060 Y Y scAAV full 1 -m54119U_210730_213233/72614656/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/72876758/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/72942081/ccs/rev 4057 Y Y scAAV full 1 -m54119U_210730_213233/73009971/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/73205972/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/73334988/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/73337070/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/73337223/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/73403165/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/73534091/ccs/rev 4081 Y Y scAAV full 1 -m54119U_210730_213233/73599284/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/73793968/ccs/fwd 4076 Y Y scAAV full 1 -m54119U_210730_213233/73795226/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/73859584/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/73861070/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/73861762/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/73925231/ccs/rev 4057 Y Y scAAV full 1 -m54119U_210730_213233/73925304/ccs/fwd 1210 Y Y scAAV right-partial 1 -m54119U_210730_213233/74058557/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/74121335/ccs/rev 4078 Y Y scAAV full 1 -m54119U_210730_213233/74122157/ccs 4293 Y Y scAAV full 1 -m54119U_210730_213233/74449772/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/74516529/ccs 3529 Y Y scAAV right-partial 1 -m54119U_210730_213233/74581558/ccs/fwd 2370 Y Y scAAV left-partial 1 -m54119U_210730_213233/74648229/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/74777090/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/75106758/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/75499074/ccs 4034 Y Y scAAV full 1 -m54119U_210730_213233/75629588/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/75825806/ccs 4089 Y Y scAAV full 1 -m54119U_210730_213233/75891155/ccs 2665 Y Y scAAV right-partial 1 -m54119U_210730_213233/76022115/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/76220429/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/76351273/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/76416807/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/76482631/ccs 4047 Y Y scAAV full 1 -m54119U_210730_213233/76678804/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/76743674/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/76744017/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/76744018/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/76745158/ccs 4083 Y Y scAAV full 1 -m54119U_210730_213233/77070738/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/77269131/ccs/fwd 4062 Y Y scAAV full 1 -m54119U_210730_213233/77334842/ccs/rev 4082 Y Y scAAV full 1 -m54119U_210730_213233/77398972/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/77531100/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/77662913/ccs/rev 2684 Y Y scAAV right-partial 1 -m54119U_210730_213233/77727627/ccs/fwd 4055 Y Y scAAV full 1 -m54119U_210730_213233/77859317/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/78382351/ccs 4108 Y Y scAAV full 1 -m54119U_210730_213233/78577944/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/78646014/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/78774307/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/78776791/ccs/rev 4054 Y Y scAAV full 1 -m54119U_210730_213233/78971014/ccs/fwd 4063 Y Y scAAV full 1 -m54119U_210730_213233/78972560/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/79102944/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/79233045/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/79496795/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/79758667/ccs 4051 Y Y scAAV full 1 -m54119U_210730_213233/79758732/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/80019702/ccs 4048 Y Y scAAV full 1 -m54119U_210730_213233/80151960/ccs 4082 Y Y scAAV full 1 -m54119U_210730_213233/80216125/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/80218761/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/80282119/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/80414687/ccs 4036 Y Y scAAV full 1 -m54119U_210730_213233/80480338/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/80480358/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/80545107/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/80545547/ccs/fwd 4060 Y Y scAAV full 1 -m54119U_210730_213233/80545753/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/80546227/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/80740990/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/80873329/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/81004303/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/81069292/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/81265051/ccs 4079 Y Y scAAV full 1 -m54119U_210730_213233/81266876/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/81330584/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/81593041/ccs 2683 Y Y scAAV right-partial 1 -m54119U_210730_213233/81659020/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/81790729/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/81856555/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/82051732/ccs 3880 Y Y scAAV full 1 -m54119U_210730_213233/82051993/ccs/fwd 1365 Y Y scAAV left-partial 1 -m54119U_210730_213233/82117299/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/82248363/ccs/rev 4087 Y Y scAAV full 1 -m54119U_210730_213233/82577737/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/82641343/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/82707895/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/82903617/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/83035988/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/83100111/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/83166536/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/83494556/ccs/fwd 4041 Y Y scAAV full 1 -m54119U_210730_213233/83625926/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/83690880/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/83755730/ccs/fwd 2338 Y Y scAAV right-partial 1 -m54119U_210730_213233/83756932/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/83821028/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/84215130/ccs/rev 4076 Y Y scAAV full 1 -m54119U_210730_213233/84216339/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/84411830/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/84740875/ccs 2513 Y Y scAAV right-partial 1 -m54119U_210730_213233/84869241/ccs/rev 4073 Y Y scAAV full 1 -m54119U_210730_213233/84871304/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/85132788/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/85198481/ccs/rev 4062 Y Y scAAV full 1 -m54119U_210730_213233/85328195/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/85394138/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/85853477/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/85853878/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/86443641/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/86706081/ccs/rev 4086 Y Y scAAV full 1 -m54119U_210730_213233/86837154/ccs/fwd 4064 Y Y scAAV full 1 -m54119U_210730_213233/87032940/ccs 4048 Y Y scAAV full 1 -m54119U_210730_213233/87230454/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/87426978/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/87491309/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/87492857/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/87558414/ccs/rev 4075 Y Y scAAV full 1 -m54119U_210730_213233/87622009/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/87689980/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/87754067/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/87950020/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/87951121/ccs 4108 Y Y scAAV full 1 -m54119U_210730_213233/88016021/ccs 2221 Y Y scAAV right-partial 1 -m54119U_210730_213233/88146643/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/88211469/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/88212120/ccs 4046 Y Y scAAV full 1 -m54119U_210730_213233/88212664/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/88214201/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/88279350/ccs 4035 Y Y scAAV full 1 -m54119U_210730_213233/88343604/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/88539677/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/88605092/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/88736040/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/88736840/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/88803932/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/89196676/ccs 4040 Y Y scAAV full 1 -m54119U_210730_213233/89391157/ccs 4048 Y Y scAAV full 1 -m54119U_210730_213233/89392453/ccs 4326 Y Y scAAV full 1 -m54119U_210730_213233/89523591/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/89524207/ccs 4078 Y Y scAAV full 1 -m54119U_210730_213233/89588382/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/89785092/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/89850181/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/89850461/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/89851499/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/89916307/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/89982603/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/90179228/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/90310131/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/90570979/ccs 4078 Y Y scAAV full 1 -m54119U_210730_213233/90573177/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/90637509/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/90638055/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/90768712/ccs 4033 Y Y scAAV full 1 -m54119U_210730_213233/90833202/ccs/fwd 4060 Y Y scAAV full 1 -m54119U_210730_213233/90833656/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/90964894/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/91161444/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/91293240/ccs/fwd 4062 Y Y scAAV full 1 -m54119U_210730_213233/91358027/ccs 543 Y N ssAAV right-partial 2 -m54119U_210730_213233/91489308/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/91554656/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/91555831/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/91751432/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/91818016/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/91818377/ccs/rev 4073 Y Y scAAV full 1 -m54119U_210730_213233/91948495/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/91949687/ccs/rev 4004 Y Y scAAV full 1 -m54119U_210730_213233/92014493/ccs 4078 Y Y scAAV full 1 -m54119U_210730_213233/92144335/ccs 4085 Y Y scAAV full 1 -m54119U_210730_213233/92341677/ccs/rev 4028 Y Y scAAV full 1 -m54119U_210730_213233/92406932/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/92406969/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/92473650/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/92604596/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/92930686/ccs 4085 Y Y scAAV full 1 -m54119U_210730_213233/92932298/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/92932593/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/92932888/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/92996161/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/92998238/ccs 3550 Y Y scAAV right-partial 1 -m54119U_210730_213233/93126773/ccs/fwd 4075 Y Y scAAV full 1 -m54119U_210730_213233/93258666/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/93324065/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/93324489/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/93521320/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/93522752/ccs 4090 Y Y scAAV full 1 -m54119U_210730_213233/93586640/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/93587689/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/93651116/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/93651943/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/93718096/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/94044594/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/94110462/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/94175534/ccs/fwd 4019 Y Y scAAV full 1 -m54119U_210730_213233/94373604/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/94373924/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/94570154/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/94570710/ccs/fwd 4046 Y Y scAAV full 1 -m54119U_210730_213233/94699612/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/95092812/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/95355016/ccs/rev 4044 Y Y scAAV full 1 -m54119U_210730_213233/95355411/ccs/fwd 1628 Y Y scAAV right-partial 1 -m54119U_210730_213233/95488664/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/95552454/ccs/rev 4052 Y Y scAAV full 1 -m54119U_210730_213233/95552742/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/95617692/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/95684780/ccs 1680 Y Y scAAV left-partial 1 -m54119U_210730_213233/95814021/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/95814586/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/95881429/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/95945975/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/96078000/ccs 4082 Y Y scAAV full 1 -m54119U_210730_213233/96142674/ccs 3993 Y Y scAAV right-partial|full 1 -m54119U_210730_213233/96274943/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/96338074/ccs 4081 Y Y scAAV full 1 -m54119U_210730_213233/96340741/ccs/fwd 3601 Y Y scAAV right-partial 1 -m54119U_210730_213233/96470358/ccs 4078 Y Y scAAV full 1 -m54119U_210730_213233/96601346/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/96796727/ccs 3941 Y Y scAAV right-partial 1 -m54119U_210730_213233/96865042/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/96928905/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/97127235/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/97388301/ccs/fwd 4052 Y Y scAAV full 1 -m54119U_210730_213233/97389130/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/97452468/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/97452604/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/97452606/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/97584810/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/97650535/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/98173190/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/98239569/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/98240457/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/98437123/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/98633436/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/98830985/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/99027080/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/99158345/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/99812755/ccs/fwd 4075 Y Y scAAV full 1 -m54119U_210730_213233/99813547/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/99878886/ccs 4013 Y Y scAAV full 1 -m54119U_210730_213233/99879454/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/99943476/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/99943707/ccs/rev 4059 Y Y scAAV full 1 -m54119U_210730_213233/100271759/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/100272872/ccs/fwd 4056 Y Y scAAV full 1 -m54119U_210730_213233/100403277/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/100468222/ccs/fwd 4086 Y Y scAAV full 1 -m54119U_210730_213233/100469161/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/100532526/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/100928028/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/100993018/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/101059009/ccs/fwd 4053 Y Y scAAV full 1 -m54119U_210730_213233/101254204/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/101451740/ccs/rev 4058 Y Y scAAV full 1 -m54119U_210730_213233/101515728/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/101518032/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/101845659/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/101910935/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/102040128/ccs 2852 Y N unclassified right-partial 1 -m54119U_210730_213233/102172852/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/102173210/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/102367907/ccs 2373 Y Y scAAV right-partial 1 -m54119U_210730_213233/102433740/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/102500270/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/102564234/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/102629569/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/102632116/ccs/rev 3988 Y Y scAAV full 1 -m54119U_210730_213233/102891788/ccs 4099 Y Y scAAV full 1 -m54119U_210730_213233/103089433/ccs 4087 Y Y scAAV full 1 -m54119U_210730_213233/103155326/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/103220355/ccs/rev 4049 Y Y scAAV full 1 -m54119U_210730_213233/103284798/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/103483931/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/103547276/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/103549493/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/103811102/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/103811376/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/103874845/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/104008436/ccs/rev 4053 Y Y scAAV full 1 -m54119U_210730_213233/104073382/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/104138467/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/104203933/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/104334079/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/104466881/ccs/fwd 2505 Y Y scAAV right-partial 1 -m54119U_210730_213233/104663728/ccs/rev 4079 Y Y scAAV full 1 -m54119U_210730_213233/104726675/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/104726953/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/104792536/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/104924174/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/105120539/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/105122626/ccs 3686 Y Y scAAV right-partial 1 -m54119U_210730_213233/105187797/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/105253297/ccs 4106 Y Y scAAV full 1 -m54119U_210730_213233/105448997/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/105842643/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/106104092/ccs 4101 Y Y scAAV full 1 -m54119U_210730_213233/106301872/ccs 3665 Y Y scAAV right-partial 1 -m54119U_210730_213233/106365663/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/106366329/ccs 2877 Y Y scAAV left-partial 1 -m54119U_210730_213233/106498146/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/106693056/ccs 4335 Y Y scAAV full 1 -m54119U_210730_213233/106694960/ccs 4047 Y Y scAAV full 1 -m54119U_210730_213233/106891988/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/107151945/ccs 3041 Y Y tandem right-partial 1 -m54119U_210730_213233/107152140/ccs/rev 4062 Y Y scAAV full 1 -m54119U_210730_213233/107282944/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/107283275/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/107284969/ccs/rev 4078 Y Y scAAV full 1 -m54119U_210730_213233/107349164/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/107414634/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/107480681/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/107545081/ccs/fwd 4063 Y Y scAAV full 1 -m54119U_210730_213233/107545840/ccs/fwd 4076 Y Y scAAV full 1 -m54119U_210730_213233/107546319/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/107678122/ccs 4050 Y Y scAAV full 1 -m54119U_210730_213233/108070762/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/108399304/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/108399372/ccs/rev 4739 Y Y scAAV full 1 -m54119U_210730_213233/108462675/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/108528247/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/108660083/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/108724835/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/108726729/ccs/rev 4073 Y Y scAAV full 1 -m54119U_210730_213233/108791485/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/108855356/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/108987022/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/109118869/ccs/fwd 4047 Y Y scAAV full 1 -m54119U_210730_213233/109251366/ccs 4050 Y Y scAAV full 1 -m54119U_210730_213233/109315468/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/109315480/ccs/fwd 4103 Y Y scAAV full 1 -m54119U_210730_213233/109380844/ccs/rev 4073 Y Y scAAV full 1 -m54119U_210730_213233/109381469/ccs/fwd 4088 Y Y scAAV full 1 -m54119U_210730_213233/109512479/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/109840697/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/110035049/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/110101885/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/110297500/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/110561367/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/110625322/ccs/rev 4051 Y Y scAAV full 1 -m54119U_210730_213233/110625981/ccs 4082 Y Y scAAV full 1 -m54119U_210730_213233/110693098/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/110757016/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/110822103/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/111150300/ccs/rev 4054 Y Y scAAV full 1 -m54119U_210730_213233/111150949/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/111413825/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/111543178/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/111607968/ccs 4087 Y Y scAAV full 1 -m54119U_210730_213233/112068361/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/112068934/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/112197932/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/112198652/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/112266062/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/112462160/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/112462208/ccs 4116 Y Y scAAV full 1 -m54119U_210730_213233/112528197/ccs/rev 4054 Y Y scAAV full 1 -m54119U_210730_213233/112591699/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/112723104/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/112921285/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/113181110/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/113182186/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/113311885/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/113377904/ccs/rev 4074 Y Y scAAV full 1 -m54119U_210730_213233/113380040/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/113445459/ccs/rev 4090 Y Y scAAV full 1 -m54119U_210730_213233/113509973/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/113640705/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/113641297/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/113771898/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/113837674/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/114099781/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/114426133/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/114559378/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/114755822/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/114950823/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/115016540/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/115017137/ccs/rev 4076 Y Y scAAV full 1 -m54119U_210730_213233/115081490/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/115081880/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/115082880/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/115082934/ccs/rev 4062 Y Y scAAV full 1 -m54119U_210730_213233/115146937/ccs/rev 4040 Y Y scAAV full 1 -m54119U_210730_213233/115345586/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/115605804/ccs 4038 Y Y scAAV full 1 -m54119U_210730_213233/115737003/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/115870071/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/115934427/ccs 4088 Y Y scAAV full 1 -m54119U_210730_213233/116131854/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/116195919/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/116261087/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/116458627/ccs/fwd 4059 Y Y scAAV full 1 -m54119U_210730_213233/116656682/ccs/fwd 3208 Y Y scAAV left-partial 1 -m54119U_210730_213233/116722260/ccs/fwd 4085 Y Y scAAV full 1 -m54119U_210730_213233/116786835/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/116850972/ccs/fwd 4041 Y Y scAAV full 1 -m54119U_210730_213233/116853051/ccs 4049 Y Y scAAV full 1 -m54119U_210730_213233/116853326/ccs/rev 4075 Y Y scAAV full 1 -m54119U_210730_213233/116984078/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/117113197/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/117180659/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/117244441/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/117310880/ccs 3960 Y Y scAAV full 1 -m54119U_210730_213233/117377393/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/117508850/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/117571996/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/117572112/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/118033210/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/118425774/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/118557245/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/118685726/ccs/rev 4047 Y Y scAAV full 1 -m54119U_210730_213233/118687082/ccs/rev 4055 Y Y scAAV full 1 -m54119U_210730_213233/119015971/ccs/fwd 4061 Y Y scAAV full 1 -m54119U_210730_213233/119080474/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/119341117/ccs/rev 4015 Y Y scAAV full 1 -m54119U_210730_213233/119407034/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/119408857/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/119409155/ccs/fwd 4087 Y Y scAAV full 1 -m54119U_210730_213233/119735863/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/119801817/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/119802416/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/119933772/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/119997087/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/120062076/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/120194358/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/120259193/ccs/fwd 4058 Y Y scAAV full 1 -m54119U_210730_213233/120324519/ccs 4053 Y Y scAAV full 1 -m54119U_210730_213233/120325935/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/120654092/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/120718086/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/120719143/ccs 4086 Y Y scAAV full 1 -m54119U_210730_213233/120783857/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/120785407/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/120914495/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/120981374/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/121045503/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/121110980/ccs 4079 Y Y scAAV full 1 -m54119U_210730_213233/121309070/ccs/fwd 4059 Y Y scAAV full 1 -m54119U_210730_213233/121504191/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/121504941/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/121832147/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/122030592/ccs 4041 Y Y scAAV full 1 -m54119U_210730_213233/122159641/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/122423520/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/122553968/ccs 4051 Y Y scAAV full 1 -m54119U_210730_213233/122619281/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/122750063/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/122815694/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/122816542/ccs/fwd 4064 Y Y scAAV full 1 -m54119U_210730_213233/122880516/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/122880728/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/123273919/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/123274842/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/123537792/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/123602765/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/123668440/ccs 4095 Y Y scAAV full 1 -m54119U_210730_213233/123865516/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/123929678/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/123995584/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/124192911/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/124258992/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/124322837/ccs/fwd 4060 Y Y scAAV full 1 -m54119U_210730_213233/124586673/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/124650076/ccs/rev 4062 Y Y scAAV full 1 -m54119U_210730_213233/124717416/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/124846864/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/124914194/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/125042951/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/125044552/ccs 2096 Y Y scAAV right-partial 1 -m54119U_210730_213233/125174195/ccs/rev 4060 Y Y scAAV full 1 -m54119U_210730_213233/125176135/ccs/fwd 4056 Y Y scAAV full 1 -m54119U_210730_213233/125305784/ccs/rev 4053 Y Y scAAV full 1 -m54119U_210730_213233/125897220/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/125960847/ccs 4039 Y Y scAAV full 1 -m54119U_210730_213233/126028074/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/126156947/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/126222668/ccs/rev 4059 Y Y scAAV full 1 -m54119U_210730_213233/126354688/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/126749257/ccs 4106 Y Y scAAV full 1 -m54119U_210730_213233/127010002/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/127208163/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/127208208/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/127404216/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/127599104/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/127796125/ccs 4039 Y Y scAAV full 1 -m54119U_210730_213233/127861669/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/127928139/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/128059769/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/128060065/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/128122911/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/128124082/ccs 4081 Y Y scAAV full 1 -m54119U_210730_213233/128254035/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/128256844/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/128320033/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/128386892/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/128516737/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/128582389/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/128714774/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/128844849/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/128975531/ccs/fwd 2693 Y Y scAAV right-partial 1 -m54119U_210730_213233/128976160/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/129173433/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/129302799/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/129434846/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/129630830/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/129695976/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/129698610/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/129761996/ccs/fwd 4062 Y Y scAAV full 1 -m54119U_210730_213233/129829130/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/129829301/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/130091719/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/130156332/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/130156679/ccs 4088 Y Y scAAV full 1 -m54119U_210730_213233/130286308/ccs 4083 Y Y scAAV full 1 -m54119U_210730_213233/130746883/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/130811022/ccs 2057 Y N ssAAV full 2 -m54119U_210730_213233/130812708/ccs/fwd 3868 Y Y scAAV right-partial 1 -m54119U_210730_213233/130812723/ccs 4044 Y Y scAAV full 1 -m54119U_210730_213233/131007863/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/131008839/ccs/rev 4060 Y Y scAAV full 1 -m54119U_210730_213233/131336803/ccs/fwd 4050 Y Y scAAV full 1 -m54119U_210730_213233/131531308/ccs/rev 4032 Y Y scAAV full 1 -m54119U_210730_213233/131532941/ccs/rev 4077 Y Y scAAV full 1 -m54119U_210730_213233/131663568/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/131793017/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/132056259/ccs/rev 4054 Y Y scAAV full 1 -m54119U_210730_213233/132057682/ccs/rev 4056 Y Y scAAV full 1 -m54119U_210730_213233/132120964/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/132317889/ccs 4032 Y Y scAAV full 1 -m54119U_210730_213233/132318199/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/132320032/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/132449736/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/132449884/ccs 4079 Y Y scAAV full 1 -m54119U_210730_213233/132777963/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/132777964/ccs 201 Y N ssAAV right-partial 2 -m54119U_210730_213233/133038810/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/133039065/ccs 4081 Y Y scAAV full 1 -m54119U_210730_213233/133497823/ccs/rev 4043 Y Y scAAV full 1 -m54119U_210730_213233/133629201/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/133630548/ccs 2052 Y Y tandem full|right-partial 1 -m54119U_210730_213233/133694941/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/133890593/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/133957402/ccs/fwd 4061 Y Y scAAV full 1 -m54119U_210730_213233/134021262/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/134154948/ccs 4088 Y Y scAAV full 1 -m54119U_210730_213233/134217733/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/134218446/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/134482665/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/134611375/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/134808340/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/134875275/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/135006772/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/135071241/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/135072452/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/135201569/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/135397841/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/135398287/ccs 4049 Y Y scAAV full 1 -m54119U_210730_213233/135398666/ccs/rev 4083 Y Y scAAV full 1 -m54119U_210730_213233/135465634/ccs 4085 Y Y scAAV full 1 -m54119U_210730_213233/135594640/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/135662347/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/136053721/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/136184778/ccs 4108 Y Y scAAV full 1 -m54119U_210730_213233/136185373/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/136250478/ccs 4085 Y Y scAAV full 1 -m54119U_210730_213233/136317108/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/136381260/ccs 1776 Y N ssAAV left-partial 2 -m54119U_210730_213233/136382238/ccs/fwd 4055 Y Y scAAV full 1 -m54119U_210730_213233/136448034/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/136448494/ccs 4050 Y Y scAAV full 1 -m54119U_210730_213233/136578042/ccs/rev 4057 Y Y scAAV full 1 -m54119U_210730_213233/136905103/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/137365172/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/137366282/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/137429944/ccs/rev 4082 Y Y scAAV full 1 -m54119U_210730_213233/137562298/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/137824852/ccs/fwd 4076 Y Y scAAV full 1 -m54119U_210730_213233/138151893/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/138281702/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/138283359/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/138348953/ccs/rev 4096 Y Y scAAV full 1 -m54119U_210730_213233/138412906/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/138477729/ccs/fwd 4064 Y Y scAAV full 1 -m54119U_210730_213233/138543815/ccs/fwd 4064 Y Y scAAV full 1 -m54119U_210730_213233/138676817/ccs/fwd 4263 Y Y scAAV full 1 -m54119U_210730_213233/138739991/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/138807021/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/138872570/ccs/rev 4076 Y Y scAAV full 1 -m54119U_210730_213233/139002500/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/139070115/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/139266623/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/139462694/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/139462847/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/139527336/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/139592677/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/139592775/ccs 4044 Y Y scAAV full 1 -m54119U_210730_213233/139725278/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/139725647/ccs 4022 Y Y scAAV full 1 -m54119U_210730_213233/140575156/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/140641904/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/140707948/ccs 4129 Y Y scAAV full 1 -m54119U_210730_213233/140773071/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/140970107/ccs/rev 4051 Y Y scAAV full 1 -m54119U_210730_213233/140970842/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/141363567/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/141428817/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/141494392/ccs 3940 Y Y scAAV full 1 -m54119U_210730_213233/141757240/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/141821362/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/141885810/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/141952522/ccs/rev 4081 Y Y scAAV full 1 -m54119U_210730_213233/142150169/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/142214328/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/142279292/ccs 3992 Y Y scAAV full 1 -m54119U_210730_213233/142346500/ccs/fwd 4079 Y Y scAAV full 1 -m54119U_210730_213233/142672656/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/142739957/ccs 4053 Y Y scAAV full 1 -m54119U_210730_213233/142803014/ccs/rev 4073 Y Y scAAV full 1 -m54119U_210730_213233/142804867/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/142868964/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/142870364/ccs/rev 4075 Y Y scAAV full 1 -m54119U_210730_213233/142934226/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/142936306/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/142936350/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/143002183/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/143067469/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/143067624/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/143133310/ccs/rev 4099 Y Y scAAV full 1 -m54119U_210730_213233/143327715/ccs 4049 Y Y scAAV full 1 -m54119U_210730_213233/143526265/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/143591064/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/143655596/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/143853143/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/144311846/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/144443171/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/144572956/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/144836932/ccs 4051 Y Y scAAV full 1 -m54119U_210730_213233/144901959/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/144902225/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/145033438/ccs 4037 Y Y scAAV full 1 -m54119U_210730_213233/145162296/ccs/fwd 4181 Y Y scAAV full 1 -m54119U_210730_213233/145228030/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/145230177/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/145230242/ccs/rev 4087 Y Y scAAV full 1 -m54119U_210730_213233/145294045/ccs 4111 Y Y scAAV full 1 -m54119U_210730_213233/145490429/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/145754389/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/145817898/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/145948946/ccs/rev 4000 Y Y scAAV full 1 -m54119U_210730_213233/146210932/ccs 4019 Y Y scAAV full 1 -m54119U_210730_213233/146211326/ccs/rev 2043 Y N ssAAV full 1 -m54119U_210730_213233/146212301/ccs 4050 Y Y scAAV full 1 -m54119U_210730_213233/146213339/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/146276460/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/146342041/ccs 4097 Y Y scAAV full 1 -m54119U_210730_213233/146342145/ccs 4057 Y Y scAAV full 1 -m54119U_210730_213233/146473986/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/146868912/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/146933975/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/147129246/ccs/rev 4028 Y Y scAAV full 1 -m54119U_210730_213233/147129809/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/147130613/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/147326991/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/147457412/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/147523843/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/147720202/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/148045911/ccs/rev 4075 Y Y scAAV full 1 -m54119U_210730_213233/148046841/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/148113552/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/148374063/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/148375445/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/148440739/ccs 3996 Y Y scAAV full 1 -m54119U_210730_213233/148507371/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/148834926/ccs/rev 4104 Y Y scAAV full 1 -m54119U_210730_213233/148899286/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/148965457/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/148965494/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/149226471/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/149292177/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/149293032/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/149554433/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/149555484/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/149685819/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/149750498/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/150077529/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/150144411/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/150144529/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/150144589/ccs/rev 4059 Y Y scAAV full 1 -m54119U_210730_213233/150144949/ccs 3973 Y Y scAAV full|right-partial 1 -m54119U_210730_213233/150209376/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/150276928/ccs 3601 Y Y scAAV right-partial 1 -m54119U_210730_213233/150406577/ccs 2008 Y N ssAAV full 2 -m54119U_210730_213233/150603985/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/150734769/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/150735446/ccs 4077 Y Y scAAV full 1 -m54119U_210730_213233/150735447/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/150735628/ccs/rev 1103 Y N unclassified right-partial 1 -m54119U_210730_213233/150930879/ccs/fwd 4078 Y Y scAAV full 1 -m54119U_210730_213233/151061986/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/151062220/ccs/rev 4003 Y Y scAAV full 1 -m54119U_210730_213233/151062465/ccs 4050 Y Y scAAV full 1 -m54119U_210730_213233/151193590/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/151259047/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/151259929/ccs 4129 Y Y scAAV full 1 -m54119U_210730_213233/151322739/ccs/rev 4087 Y Y scAAV full 1 -m54119U_210730_213233/151521383/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/151585144/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/151586142/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/151587001/ccs/fwd 2040 Y N ssAAV full 1 -m54119U_210730_213233/151782700/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/151848373/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/152177039/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/152241954/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/152242214/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/152306591/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/152374074/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/152502720/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/152502725/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/152765530/ccs/fwd 4056 Y Y scAAV full 1 -m54119U_210730_213233/152831929/ccs 4080 Y Y scAAV full 1 -m54119U_210730_213233/152963609/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/153159460/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/153290271/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/153356271/ccs/rev 4055 Y Y scAAV full 1 -m54119U_210730_213233/153420905/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/153486938/ccs 4113 Y Y scAAV full 1 -m54119U_210730_213233/153488078/ccs 4126 Y Y scAAV full 1 -m54119U_210730_213233/153619130/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/153684405/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/153748686/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/153813296/ccs/fwd 4081 Y Y scAAV full 1 -m54119U_210730_213233/153815758/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/153881321/ccs 4041 Y Y scAAV full 1 -m54119U_210730_213233/154010541/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/154011354/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/154075504/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/154075866/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/154207438/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/154272113/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/154273678/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/154403170/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/154471201/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/154536499/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/154599965/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/154667566/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/154731571/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/154863132/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/154864187/ccs/fwd 997 Y N ssAAV right-partial 1 -m54119U_210730_213233/154929371/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/155058461/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/155255069/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/155255396/ccs 4097 Y Y scAAV full 1 -m54119U_210730_213233/155322452/ccs/rev 4048 Y Y scAAV full 1 -m54119U_210730_213233/155322627/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/155385895/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/155387228/ccs/rev 4047 Y Y scAAV full 1 -m54119U_210730_213233/155388064/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/155388216/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/155582998/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/155713804/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/155780355/ccs/rev 4082 Y Y scAAV full 1 -m54119U_210730_213233/155781528/ccs/rev 4062 Y Y scAAV full 1 -m54119U_210730_213233/155911461/ccs/fwd 4051 Y Y scAAV full 1 -m54119U_210730_213233/156041803/ccs 4098 Y Y scAAV full 1 -m54119U_210730_213233/156042579/ccs 2035 Y N ssAAV full 2 -m54119U_210730_213233/156238356/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/156500125/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/156502551/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/156567927/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/156697182/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/156829865/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/157090820/ccs 4078 Y Y scAAV full 1 -m54119U_210730_213233/157157941/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/157221440/ccs/rev 4054 Y Y scAAV full 1 -m54119U_210730_213233/157287583/ccs 3982 Y Y scAAV full 1 -m54119U_210730_213233/157288346/ccs/fwd 4078 Y Y scAAV full 1 -m54119U_210730_213233/157352711/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/157353023/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/157485503/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/157680370/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/157680691/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/157681120/ccs/rev 4060 Y Y scAAV full 1 -m54119U_210730_213233/157681540/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/157745261/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/157746758/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/157811090/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/157943813/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/158007821/ccs 3895 Y Y scAAV full|right-partial 1 -m54119U_210730_213233/158009565/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/158271398/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/158400804/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/158401506/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/158402074/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/158467182/ccs 4080 Y Y scAAV full 1 -m54119U_210730_213233/158534075/ccs/fwd 4086 Y Y scAAV full 1 -m54119U_210730_213233/158534439/ccs 4146 Y Y scAAV full 1 -m54119U_210730_213233/158664577/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/158665075/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/158860611/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/158927277/ccs/fwd 4075 Y Y scAAV full 1 -m54119U_210730_213233/159121909/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/159123223/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/159124056/ccs/rev 4081 Y Y scAAV full 1 -m54119U_210730_213233/159189442/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/159252863/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/159319058/ccs/fwd 4061 Y Y scAAV full 1 -m54119U_210730_213233/159320176/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/159450482/ccs 4900 Y Y scAAV full 1 -m54119U_210730_213233/159451551/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/159580563/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/159778670/ccs/fwd 4074 Y Y scAAV full 1 -m54119U_210730_213233/159843695/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/160041811/ccs/rev 4049 Y Y scAAV full 1 -m54119U_210730_213233/160301057/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/160368986/ccs/fwd 4076 Y Y scAAV full 1 -m54119U_210730_213233/160563815/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/160564783/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/160630086/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/160826027/ccs/fwd 4066 Y Y scAAV full 1 -m54119U_210730_213233/160828166/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/160892350/ccs 4044 Y Y scAAV full 1 -m54119U_210730_213233/161023992/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/161154362/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/161154597/ccs 4045 Y Y scAAV full 1 -m54119U_210730_213233/161286424/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/161349672/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/161481485/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/161481950/ccs/rev 4072 Y Y scAAV full 1 -m54119U_210730_213233/161941384/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/162070792/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/162204294/ccs 4145 Y Y scAAV full 1 -m54119U_210730_213233/162267972/ccs 4083 Y Y scAAV full 1 -m54119U_210730_213233/162268821/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/162269149/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/162333042/ccs 4052 Y Y scAAV full 1 -m54119U_210730_213233/162400031/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/162531310/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/162531803/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/162596235/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/162597331/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/162662226/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/162727218/ccs/rev 4074 Y Y scAAV full 1 -m54119U_210730_213233/162859530/ccs 2744 Y N unclassified vector+backbone 1 -m54119U_210730_213233/163055046/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/163120172/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/163121003/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/163121698/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/163317501/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/163449564/ccs/fwd 4077 Y Y scAAV full 1 -m54119U_210730_213233/163710890/ccs/fwd 4059 Y Y scAAV full 1 -m54119U_210730_213233/163775371/ccs/fwd 4048 Y Y scAAV full 1 -m54119U_210730_213233/163842018/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/163907845/ccs 4046 Y Y scAAV full 1 -m54119U_210730_213233/163971443/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/164036759/ccs 4059 Y Y scAAV full 1 -m54119U_210730_213233/164233784/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/164235756/ccs 2459 Y Y scAAV right-partial 1 -m54119U_210730_213233/164364650/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/164496864/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/164562072/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/164759689/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/164891066/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/164956966/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/165086990/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/165087169/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/165153107/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/165217909/ccs 4083 Y Y scAAV full 1 -m54119U_210730_213233/165283825/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/165347547/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/165414730/ccs/rev 4062 Y Y scAAV full 1 -m54119U_210730_213233/165480688/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/165546618/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/165610732/ccs/fwd 4062 Y Y scAAV full 1 -m54119U_210730_213233/165611335/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/165675605/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/165808053/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/165808533/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/165872176/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/165872455/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/166068583/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/166069146/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/166134996/ccs/rev 3945 Y Y scAAV right-partial 1 -m54119U_210730_213233/166199732/ccs/fwd 4073 Y Y scAAV full 1 -m54119U_210730_213233/166266112/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/166331680/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/166527928/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/166660920/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/166726137/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/166921521/ccs 4053 Y Y scAAV full 1 -m54119U_210730_213233/167053669/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/167773946/ccs/rev 4103 Y Y scAAV full 1 -m54119U_210730_213233/167774826/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/167838243/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/168036147/ccs 3989 Y Y scAAV full 1 -m54119U_210730_213233/168297893/ccs/rev 4080 Y Y scAAV full 1 -m54119U_210730_213233/168298512/ccs/fwd 4231 Y Y scAAV full 1 -m54119U_210730_213233/168362549/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/168363384/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/168624781/ccs/rev 4059 Y Y scAAV full 1 -m54119U_210730_213233/168822046/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/169018936/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/169084873/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/169150553/ccs 4088 Y Y scAAV full 1 -m54119U_210730_213233/169214717/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/169412465/ccs/rev 4074 Y Y scAAV full 1 -m54119U_210730_213233/169412765/ccs/rev 4078 Y Y scAAV full 1 -m54119U_210730_213233/169412838/ccs/rev 4070 Y Y scAAV full 1 -m54119U_210730_213233/169413004/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/169608424/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/169740452/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/169741026/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/170066884/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/170068796/ccs/rev 4067 Y Y scAAV full 1 -m54119U_210730_213233/170132474/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/170265077/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/170396311/ccs/rev 1501 Y Y scAAV right-partial 1 -m54119U_210730_213233/170525791/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/170592326/ccs 4080 Y Y scAAV full 1 -m54119U_210730_213233/170657419/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/170658642/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/170853192/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/170853331/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/170920103/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/171051797/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/171115691/ccs 4062 Y Y scAAV full 1 -m54119U_210730_213233/171116362/ccs/rev 4061 Y Y scAAV full 1 -m54119U_210730_213233/171180984/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/171182929/ccs 4044 Y Y scAAV full 1 -m54119U_210730_213233/171247201/ccs 4083 Y Y scAAV full 1 -m54119U_210730_213233/171376984/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/171378166/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/171444934/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/171639031/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/171639148/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/171902476/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/171968969/ccs 4050 Y Y scAAV full 1 -m54119U_210730_213233/172032035/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/172098543/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/172163480/ccs 4042 Y Y scAAV full 1 -m54119U_210730_213233/172296061/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/172491773/ccs 4080 Y Y scAAV full 1 -m54119U_210730_213233/172492267/ccs 4038 Y Y scAAV full 1 -m54119U_210730_213233/172689978/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/172820364/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/172884392/ccs/fwd 4062 Y Y scAAV full 1 -m54119U_210730_213233/172886135/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/172950121/ccs/rev 2277 Y Y scAAV partial 1 -m54119U_210730_213233/173016020/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/173081150/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/173082485/ccs/fwd 3912 Y Y scAAV right-partial 1 -m54119U_210730_213233/173279676/ccs 4078 Y Y scAAV full 1 -m54119U_210730_213233/173345260/ccs/fwd 4065 Y Y scAAV full 1 -m54119U_210730_213233/173539940/ccs 4075 Y Y scAAV full 1 -m54119U_210730_213233/173801553/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/173801996/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/173802537/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/173867203/ccs 4079 Y Y scAAV full 1 -m54119U_210730_213233/174000413/ccs/fwd 4064 Y Y scAAV full 1 -m54119U_210730_213233/174131960/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/174260603/ccs 4041 Y Y scAAV full 1 -m54119U_210730_213233/174261205/ccs/rev 4063 Y Y scAAV full 1 -m54119U_210730_213233/174326029/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/174391916/ccs/fwd 4071 Y Y scAAV full 1 -m54119U_210730_213233/174457571/ccs/rev 4066 Y Y scAAV full 1 -m54119U_210730_213233/174523234/ccs/rev 4081 Y Y scAAV full 1 -m54119U_210730_213233/174654098/ccs 4142 Y Y scAAV full 1 -m54119U_210730_213233/174784722/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/174787420/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/174917272/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/175048548/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/175178840/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/175245877/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/175308818/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/175377195/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/175506899/ccs 4076 Y Y scAAV full 1 -m54119U_210730_213233/175637275/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/175833386/ccs 3216 Y Y scAAV left-partial 1 -m54119U_210730_213233/176097882/ccs/fwd 4068 Y Y scAAV full 1 -m54119U_210730_213233/176227919/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/176228326/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/176292366/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/176292385/ccs 3165 Y Y scAAV right-partial 1 -m54119U_210730_213233/176293536/ccs 4090 Y Y scAAV full 1 -m54119U_210730_213233/176294743/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/176357895/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/176423457/ccs 4083 Y Y scAAV full 1 -m54119U_210730_213233/176424847/ccs 2521 Y Y scAAV left-partial 1 -m54119U_210730_213233/176489118/ccs 4048 Y Y scAAV full 1 -m54119U_210730_213233/176489774/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/176491155/ccs 3987 Y Y scAAV full 1 -m54119U_210730_213233/176554459/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/176554990/ccs 2095 Y Y scAAV right-partial 1 -m54119U_210730_213233/176556430/ccs/fwd 4070 Y Y scAAV full 1 -m54119U_210730_213233/176752256/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/176816527/ccs/rev 4064 Y Y scAAV full 1 -m54119U_210730_213233/176818733/ccs 4063 Y Y scAAV full 1 -m54119U_210730_213233/176949770/ccs 4082 Y Y scAAV full 1 -m54119U_210730_213233/177014829/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/177080498/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/177080942/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/177144100/ccs 4069 Y Y scAAV full 1 -m54119U_210730_213233/177145679/ccs/rev 4058 Y Y scAAV full 1 -m54119U_210730_213233/177275525/ccs 4055 Y Y scAAV full 1 -m54119U_210730_213233/177277101/ccs 4073 Y Y scAAV full 1 -m54119U_210730_213233/177407048/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/177408109/ccs 4061 Y Y scAAV full 1 -m54119U_210730_213233/177472900/ccs 4056 Y Y scAAV full 1 -m54119U_210730_213233/177670348/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/177733633/ccs/rev 4069 Y Y scAAV full 1 -m54119U_210730_213233/177736001/ccs 4058 Y Y scAAV full 1 -m54119U_210730_213233/177800197/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/177801206/ccs 4054 Y Y scAAV full 1 -m54119U_210730_213233/177865402/ccs 4067 Y Y scAAV full 1 -m54119U_210730_213233/178127515/ccs 4043 Y Y scAAV full 1 -m54119U_210730_213233/178129693/ccs 4060 Y Y scAAV full 1 -m54119U_210730_213233/178259474/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/178456038/ccs/rev 4068 Y Y scAAV full 1 -m54119U_210730_213233/178456987/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/178586886/ccs 4031 Y Y scAAV full 1 -m54119U_210730_213233/178783443/ccs/rev 4052 Y Y scAAV full 1 -m54119U_210730_213233/178849668/ccs/rev 4065 Y Y scAAV full 1 -m54119U_210730_213233/178913629/ccs 1468 Y Y scAAV right-partial 1 -m54119U_210730_213233/178979792/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/179046565/ccs/fwd 4072 Y Y scAAV full 1 -m54119U_210730_213233/179109930/ccs 4066 Y Y scAAV full 1 -m54119U_210730_213233/179110510/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/179112069/ccs 4072 Y Y scAAV full 1 -m54119U_210730_213233/179242164/ccs/fwd 4054 Y Y scAAV full 1 -m54119U_210730_213233/179242703/ccs/fwd 4067 Y Y scAAV full 1 -m54119U_210730_213233/179374011/ccs/rev 3198 Y Y scAAV vector+backbone 1 -m54119U_210730_213233/179374412/ccs 4051 Y Y scAAV full 1 -m54119U_210730_213233/179503387/ccs 4068 Y Y scAAV full 1 -m54119U_210730_213233/179568832/ccs 4065 Y Y scAAV full 1 -m54119U_210730_213233/179569383/ccs 3160 Y Y scAAV right-partial 1 -m54119U_210730_213233/179635778/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/179832258/ccs 4071 Y Y scAAV full 1 -m54119U_210730_213233/179897457/ccs 4074 Y Y scAAV full 1 -m54119U_210730_213233/179964280/ccs 4090 Y Y scAAV full 1 -m54119U_210730_213233/180289742/ccs/rev 4071 Y Y scAAV full 1 -m54119U_210730_213233/180355768/ccs/fwd 4075 Y Y scAAV full 1 -m54119U_210730_213233/180356757/ccs/fwd 4069 Y Y scAAV full 1 -m54119U_210730_213233/180357035/ccs 4064 Y Y scAAV full 1 -m54119U_210730_213233/180421837/ccs 4070 Y Y scAAV full 1 -m54119U_210730_213233/180553447/ccs/fwd 4068 Y Y scAAV full 1 diff --git a/test/build-snapshot/ss.flipflop.tsv b/test/build-snapshot/ss.flipflop.tsv deleted file mode 100644 index bd0c380..0000000 --- a/test/build-snapshot/ss.flipflop.tsv +++ /dev/null @@ -1,31 +0,0 @@ -type subtype leftITR rightITR count -scAAV vector-full flip flip 223 -scAAV vector-full flip flop 207 -scAAV vector-full flip unclassified 238 -scAAV vector-full flop flip 213 -scAAV vector-full flop flop 232 -scAAV vector-full flop unclassified 195 -scAAV vector-full unclassified flip 214 -scAAV vector-full unclassified flop 200 -scAAV vector-full unclassified unclassified 362 -scAAV vector-left-partial flip unclassified 130 -scAAV vector-left-partial flop unclassified 136 -scAAV vector-left-partial unclassified unclassified 109 -scAAV vector-right-partial unclassified flip 316 -scAAV vector-right-partial unclassified flop 294 -scAAV vector-right-partial unclassified unclassified 329 -ssAAV vector-full flip flip 185 -ssAAV vector-full flip flop 207 -ssAAV vector-full flip unclassified 52 -ssAAV vector-full flop flip 218 -ssAAV vector-full flop flop 199 -ssAAV vector-full flop unclassified 69 -ssAAV vector-full unclassified flip 63 -ssAAV vector-full unclassified flop 57 -ssAAV vector-full unclassified unclassified 113 -ssAAV vector-left-partial flip unclassified 25 -ssAAV vector-left-partial flop unclassified 38 -ssAAV vector-left-partial unclassified unclassified 24 -ssAAV vector-right-partial unclassified flip 70 -ssAAV vector-right-partial unclassified flop 86 -ssAAV vector-right-partial unclassified unclassified 34 diff --git a/test/build-snapshot/ss.per_read.tsv b/test/build-snapshot/ss.per_read.tsv deleted file mode 100644 index d94ed66..0000000 --- a/test/build-snapshot/ss.per_read.tsv +++ /dev/null @@ -1,3518 +0,0 @@ -read_id read_len has_primary has_supp assigned_type assigned_subtype effective_count -m64011_220616_211638/66498/ccs 3597 Y Y scAAV full 1 -m64011_220616_211638/67481/ccs/rev 2966 Y Y scAAV left-partial 1 -m64011_220616_211638/132033/ccs/rev 2618 Y N ssAAV right-partial 1 -m64011_220616_211638/132147/ccs 4677 Y Y scAAV full 1 -m64011_220616_211638/328788/ccs/fwd 4698 Y Y scAAV full 1 -m64011_220616_211638/328836/ccs/fwd 2453 Y N ssAAV full 1 -m64011_220616_211638/329005/ccs 1817 Y Y scAAV right-partial|partial 1 -m64011_220616_211638/330470/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/395873/ccs 2370 Y Y tandem full|right-partial 1 -m64011_220616_211638/459822/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/525187/ccs 2446 Y N ssAAV full 2 -m64011_220616_211638/656622/ccs 2211 Y N ssAAV right-partial 2 -m64011_220616_211638/721933/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/787499/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/787829/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/789141/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/852682/ccs/fwd 2453 Y N ssAAV full 1 -m64011_220616_211638/852730/ccs/rev 4703 Y Y scAAV full 1 -m64011_220616_211638/853296/ccs/fwd 2368 Y N ssAAV right-partial 1 -m64011_220616_211638/917770/ccs 2592 Y N ssAAV left-partial 2 -m64011_220616_211638/918554/ccs/fwd 956 Y N unclassified right-partial 1 -m64011_220616_211638/918603/ccs/fwd 4786 Y Y scAAV full 1 -m64011_220616_211638/919842/ccs/fwd 2448 Y N ssAAV full 1 -m64011_220616_211638/983495/ccs 4377 Y Y repcap NA 1 -m64011_220616_211638/1051342/ccs 2473 Y Y scAAV right-partial 1 -m64011_220616_211638/1115061/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/1116496/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/1180754/ccs 4541 Y N unclassified right-partial 1 -m64011_220616_211638/1180805/ccs/fwd 4513 Y Y scAAV left-partial 1 -m64011_220616_211638/1181930/ccs/rev 4392 Y Y scAAV full 1 -m64011_220616_211638/1246810/ccs 5221 Y Y scAAV full 1 -m64011_220616_211638/1311425/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/1312597/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/1376890/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/1378546/ccs/rev 4787 Y Y scAAV full 1 -m64011_220616_211638/1444177/ccs/rev 4777 Y Y scAAV full 1 -m64011_220616_211638/1508757/ccs/fwd 4770 Y Y scAAV full 1 -m64011_220616_211638/1771670/ccs/rev 4710 Y Y scAAV full 1 -m64011_220616_211638/1901520/ccs 1145 Y Y scAAV left-partial 1 -m64011_220616_211638/1902286/ccs/fwd 4699 Y Y scAAV full 1 -m64011_220616_211638/1903356/ccs 4687 Y Y scAAV full 1 -m64011_220616_211638/1968035/ccs 2287 Y Y scAAV left-partial 1 -m64011_220616_211638/1968344/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/2032484/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/2033590/ccs/rev 4778 Y Y scAAV full 1 -m64011_220616_211638/2099136/ccs/rev 4755 Y Y scAAV full 1 -m64011_220616_211638/2162947/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/2165071/ccs 2378 Y N ssAAV right-partial 2 -m64011_220616_211638/2229598/ccs 4761 Y Y scAAV full 1 -m64011_220616_211638/2230251/ccs/fwd 1726 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/2230465/ccs 2420 Y Y scAAV full|right-partial 1 -m64011_220616_211638/2294546/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/2296553/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/2359830/ccs 826 Y Y scAAV partial 1 -m64011_220616_211638/2361485/ccs/rev 4791 Y Y scAAV full 1 -m64011_220616_211638/2557759/ccs 4698 Y Y scAAV full 1 -m64011_220616_211638/2557966/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/2623613/ccs/rev 3498 Y Y scAAV left-partial 1 -m64011_220616_211638/2688161/ccs 1824 Y Y scAAV backbone|right-partial 1 -m64011_220616_211638/2754976/ccs/rev 4704 Y Y scAAV full 1 -m64011_220616_211638/2884703/ccs 124 Y N ssAAV right-partial 2 -m64011_220616_211638/2885785/ccs/fwd 3433 Y Y scAAV right-partial 1 -m64011_220616_211638/2951896/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/3015012/ccs 2133 Y N unclassified right-partial 1 -m64011_220616_211638/3016589/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/3081241/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/3147302/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/3279689/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/3408169/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/3476303/ccs 4615 Y Y scAAV right-partial 1 -m64011_220616_211638/3539816/ccs 2422 Y N ssAAV full 2 -m64011_220616_211638/3540436/ccs/fwd 1296 Y N unclassified right-partial 1 -m64011_220616_211638/3541019/ccs/rev 4781 Y Y scAAV full 1 -m64011_220616_211638/3606172/ccs/fwd 4758 Y Y scAAV full 1 -m64011_220616_211638/3737601/ccs 2661 Y Y scAAV right-partial 1 -m64011_220616_211638/3803148/ccs/fwd 3107 Y Y scAAV left-partial 1 -m64011_220616_211638/3803385/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/3868231/ccs 2086 Y N ssAAV right-partial 2 -m64011_220616_211638/3868737/ccs 2298 Y N ssAAV left-partial 2 -m64011_220616_211638/3934111/ccs/rev 4782 Y Y scAAV full 1 -m64011_220616_211638/3999195/ccs/fwd 723 Y Y scAAV right-partial 1 -m64011_220616_211638/4063239/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/4064985/ccs/rev 826 Y Y scAAV right-partial 1 -m64011_220616_211638/4066074/ccs 1772 Y N ssAAV right-partial 2 -m64011_220616_211638/4130294/ccs/fwd 4688 Y Y scAAV full 1 -m64011_220616_211638/4260903/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/4261929/ccs 4765 Y Y scAAV full 1 -m64011_220616_211638/4262438/ccs 4774 Y Y scAAV full 1 -m64011_220616_211638/4326165/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/4326921/ccs 2955 Y N ssAAV right-partial 2 -m64011_220616_211638/4391424/ccs/rev 4784 Y Y scAAV full 1 -m64011_220616_211638/4457145/ccs/fwd 3572 Y Y scAAV right-partial 1 -m64011_220616_211638/4457896/ccs/rev 4774 Y Y scAAV full 1 -m64011_220616_211638/4458784/ccs/fwd 1685 Y N unclassified right-partial 1 -m64011_220616_211638/4522431/ccs/fwd 2254 Y Y scAAV right-partial 1 -m64011_220616_211638/4524259/ccs 1845 Y N ssAAV right-partial 2 -m64011_220616_211638/4589703/ccs 4771 Y Y scAAV full 1 -m64011_220616_211638/4719043/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/4851253/ccs 2442 Y N ssAAV full 2 -m64011_220616_211638/4982408/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/5177596/ccs 4804 Y Y scAAV full 1 -m64011_220616_211638/5309171/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/5310320/ccs/rev 4781 Y Y scAAV full 1 -m64011_220616_211638/5310735/ccs 2507 Y N ssAAV full 2 -m64011_220616_211638/5376232/ccs 4755 Y Y scAAV full 1 -m64011_220616_211638/5441953/ccs/fwd 4699 Y Y scAAV full 1 -m64011_220616_211638/5506965/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/5506979/ccs/fwd 4736 Y Y scAAV full 1 -m64011_220616_211638/5636117/ccs 2378 Y N ssAAV full 2 -m64011_220616_211638/5833251/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/5899241/ccs/fwd 4786 Y Y scAAV full 1 -m64011_220616_211638/5899926/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/5966169/ccs/rev 4954 Y Y scAAV full 1 -m64011_220616_211638/6161596/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/6163012/ccs/rev 914 Y Y scAAV right-partial 1 -m64011_220616_211638/6226489/ccs 2499 Y N ssAAV full 2 -m64011_220616_211638/6293209/ccs/fwd 4780 Y Y scAAV full 1 -m64011_220616_211638/6357106/ccs/fwd 4715 Y Y scAAV full 1 -m64011_220616_211638/6423306/ccs 2406 Y Y tandem full|right-partial 1 -m64011_220616_211638/6424913/ccs/rev 4783 Y Y scAAV full 1 -m64011_220616_211638/6490326/ccs/fwd 2670 Y N ssAAV full 1 -m64011_220616_211638/6554050/ccs 2518 Y N ssAAV full 2 -m64011_220616_211638/6555255/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/6555471/ccs 2293 Y N ssAAV left-partial 2 -m64011_220616_211638/6619566/ccs 2426 Y N ssAAV full 2 -m64011_220616_211638/6751892/ccs 2464 Y N ssAAV full 2 -m64011_220616_211638/6815746/ccs 1540 Y N ssAAV right-partial 2 -m64011_220616_211638/6816514/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/6949413/ccs 4683 Y Y scAAV full 1 -m64011_220616_211638/7012898/ccs 1867 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/7014970/ccs 995 Y Y scAAV partial 1 -m64011_220616_211638/7210347/ccs 4754 Y Y scAAV full 1 -m64011_220616_211638/7275080/ccs 4677 Y Y scAAV full 1 -m64011_220616_211638/7276479/ccs/fwd 3615 Y Y scAAV right-partial 1 -m64011_220616_211638/7276863/ccs/rev 3706 Y Y scAAV right-partial 1 -m64011_220616_211638/7342187/ccs/fwd 2888 Y N unclassified right-partial 1 -m64011_220616_211638/7405627/ccs/rev 4815 Y Y scAAV full 1 -m64011_220616_211638/7407607/ccs 2370 Y Y scAAV full|right-partial 1 -m64011_220616_211638/7669808/ccs 2411 Y N ssAAV full 2 -m64011_220616_211638/7734928/ccs/rev 2410 Y Y tandem full|right-partial 1 -m64011_220616_211638/7734968/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/7864829/ccs/fwd 2410 Y N ssAAV full 1 -m64011_220616_211638/7866074/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/7998018/ccs/fwd 1410 Y Y scAAV left-partial 1 -m64011_220616_211638/8193358/ccs 4764 Y Y scAAV full 1 -m64011_220616_211638/8257973/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/8324495/ccs/fwd 3904 Y Y scAAV right-partial 1 -m64011_220616_211638/8325551/ccs 4794 Y Y scAAV full 1 -m64011_220616_211638/8520502/ccs 2444 Y N ssAAV full 2 -m64011_220616_211638/8521838/ccs 1940 Y Y scAAV right-partial 1 -m64011_220616_211638/8587417/ccs 1441 Y Y scAAV left-partial 1 -m64011_220616_211638/8587710/ccs 1812 Y N ssAAV right-partial 2 -m64011_220616_211638/8651962/ccs 4623 Y Y scAAV full 1 -m64011_220616_211638/8783989/ccs 4700 Y Y scAAV full 1 -m64011_220616_211638/8784660/ccs/rev 3433 Y Y scAAV right-partial 1 -m64011_220616_211638/8914206/ccs 2410 Y N ssAAV full 2 -m64011_220616_211638/8980135/ccs/rev 2535 Y Y scAAV right-partial 1 -m64011_220616_211638/9045379/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/9046648/ccs 4922 Y Y scAAV full 1 -m64011_220616_211638/9110099/ccs 2238 Y N ssAAV right-partial 2 -m64011_220616_211638/9111062/ccs 4787 Y Y scAAV full 1 -m64011_220616_211638/9111452/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/9176192/ccs/fwd 2454 Y N ssAAV full 1 -m64011_220616_211638/9177095/ccs 4787 Y Y scAAV full 1 -m64011_220616_211638/9241136/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/9306404/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/9373002/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/9437887/ccs/fwd 1646 Y Y scAAV right-partial 1 -m64011_220616_211638/9439229/ccs/fwd 4408 Y Y scAAV left-partial 1 -m64011_220616_211638/9569795/ccs 2413 Y N ssAAV full 2 -m64011_220616_211638/9700310/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/9832747/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/9962102/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/9962724/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/10027410/ccs 1114 Y N ssAAV right-partial 2 -m64011_220616_211638/10158567/ccs/rev 1294 Y Y scAAV right-partial 1 -m64011_220616_211638/10160572/ccs 4739 Y Y scAAV full 1 -m64011_220616_211638/10160903/ccs 2770 Y N unclassified right-partial 1 -m64011_220616_211638/10290733/ccs 2444 Y N ssAAV full 2 -m64011_220616_211638/10291637/ccs 4242 Y Y scAAV right-partial 1 -m64011_220616_211638/10357526/ccs/fwd 2251 Y N unclassified right-partial 1 -m64011_220616_211638/10486296/ccs/fwd 1480 Y N unclassified right-partial 1 -m64011_220616_211638/10487121/ccs 4763 Y Y scAAV full 1 -m64011_220616_211638/10618830/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/10682910/ccs/fwd 2213 Y N ssAAV right-partial 1 -m64011_220616_211638/10683673/ccs/fwd 4780 Y Y scAAV full 1 -m64011_220616_211638/10748264/ccs/rev 4793 Y Y scAAV full 1 -m64011_220616_211638/10813662/ccs 2813 Y Y scAAV right-partial 1 -m64011_220616_211638/10814435/ccs 4694 Y Y scAAV full 1 -m64011_220616_211638/10814733/ccs/rev 4774 Y Y scAAV full 1 -m64011_220616_211638/10944898/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/10946791/ccs/fwd 2456 Y N ssAAV full 1 -m64011_220616_211638/11010703/ccs/rev 4838 Y Y scAAV full 1 -m64011_220616_211638/11141531/ccs 3756 Y Y scAAV right-partial 1 -m64011_220616_211638/11142063/ccs 2174 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/11273836/ccs 2915 Y N ssAAV right-partial 2 -m64011_220616_211638/11338603/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/11403346/ccs 4933 Y Y scAAV full 1 -m64011_220616_211638/11405978/ccs 4788 Y Y scAAV full 1 -m64011_220616_211638/11471652/ccs 2530 Y N helper NA 1 -m64011_220616_211638/11535883/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/11537014/ccs 4699 Y Y scAAV full 1 -m64011_220616_211638/11732381/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/11733552/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/11799026/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/11862542/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/11862809/ccs/rev 2824 Y Y scAAV right-partial 1 -m64011_220616_211638/11928402/ccs/rev 4782 Y Y scAAV full 1 -m64011_220616_211638/11928853/ccs 3505 Y Y scAAV right-partial 1 -m64011_220616_211638/11930444/ccs 1765 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/11994839/ccs/rev 4771 Y Y scAAV full 1 -m64011_220616_211638/11995009/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/12059753/ccs 2075 Y N ssAAV right-partial 2 -m64011_220616_211638/12125622/ccs/rev 2370 Y N ssAAV full 1 -m64011_220616_211638/12386794/ccs/fwd 4710 Y Y scAAV full 1 -m64011_220616_211638/12388725/ccs 2439 Y N ssAAV full 2 -m64011_220616_211638/12453182/ccs 4817 Y Y scAAV right-partial|left-partial 1 -m64011_220616_211638/12453802/ccs 2420 Y Y tandem full|right-partial 1 -m64011_220616_211638/12517536/ccs/rev 4721 Y Y scAAV full 1 -m64011_220616_211638/12519655/ccs 1780 Y Y scAAV right-partial 1 -m64011_220616_211638/12585041/ccs/fwd 4764 Y Y scAAV full 1 -m64011_220616_211638/12779919/ccs/fwd 4126 Y Y scAAV right-partial 1 -m64011_220616_211638/12911921/ccs/rev 2455 Y N ssAAV full 1 -m64011_220616_211638/13042648/ccs 1810 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/13042993/ccs 3879 Y Y scAAV right-partial 1 -m64011_220616_211638/13043130/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/13174212/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/13240758/ccs 4710 Y Y scAAV full 1 -m64011_220616_211638/13304375/ccs 2464 Y N ssAAV full 2 -m64011_220616_211638/13305100/ccs/fwd 4806 Y Y scAAV full 1 -m64011_220616_211638/13306447/ccs 1799 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/13369575/ccs 4841 Y Y scAAV full 1 -m64011_220616_211638/13370550/ccs/fwd 1752 Y Y scAAV right-partial 1 -m64011_220616_211638/13436897/ccs/fwd 4805 Y Y scAAV full 1 -m64011_220616_211638/13501737/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/13634157/ccs/fwd 4785 Y Y scAAV full 1 -m64011_220616_211638/13697266/ccs/rev 4791 Y Y scAAV full 1 -m64011_220616_211638/13698681/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/13764147/ccs 2552 Y N ssAAV full 2 -m64011_220616_211638/13764394/ccs/fwd 5521 Y Y scAAV full 1 -m64011_220616_211638/13828491/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/13828781/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/13830330/ccs 752 Y Y scAAV right-partial 1 -m64011_220616_211638/13895134/ccs 2327 Y Y scAAV left-partial 1 -m64011_220616_211638/13896233/ccs 2439 Y N ssAAV full 2 -m64011_220616_211638/13959449/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/13961473/ccs 2328 Y N ssAAV full 2 -m64011_220616_211638/13961494/ccs/rev 4758 Y Y scAAV full 1 -m64011_220616_211638/14027502/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/14091770/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/14221825/ccs/rev 3568 Y Y scAAV right-partial 1 -m64011_220616_211638/14287265/ccs 1858 Y Y scAAV left-partial 1 -m64011_220616_211638/14353995/ccs/rev 4700 Y Y scAAV full 1 -m64011_220616_211638/14419369/ccs/rev 2400 Y N ssAAV full 1 -m64011_220616_211638/14485356/ccs 2412 Y Y scAAV full|right-partial 1 -m64011_220616_211638/14485506/ccs 3639 Y Y scAAV right-partial 1 -m64011_220616_211638/14486122/ccs 2660 Y Y tandem full|left-partial 1 -m64011_220616_211638/14550836/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/14615192/ccs 4545 Y Y scAAV full|right-partial 1 -m64011_220616_211638/14615968/ccs/rev 3435 Y Y scAAV right-partial 1 -m64011_220616_211638/14616267/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/14616352/ccs 3697 Y Y scAAV left-partial 1 -m64011_220616_211638/14681589/ccs 4284 Y Y scAAV left-partial 1 -m64011_220616_211638/14681638/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/14681730/ccs 4491 Y Y scAAV full 1 -m64011_220616_211638/14682654/ccs 2074 Y N ssAAV left-partial 2 -m64011_220616_211638/14812457/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/14812935/ccs 1423 Y N ssAAV partial 2 -m64011_220616_211638/14943360/ccs/rev 1994 Y N ssAAV right-partial 1 -m64011_220616_211638/14944868/ccs 1327 Y Y scAAV right-partial 1 -m64011_220616_211638/14944998/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/15008771/ccs 4204 Y N host NA 1 -m64011_220616_211638/15010338/ccs 3122 Y Y scAAV right-partial 1 -m64011_220616_211638/15073942/ccs 2413 Y Y scAAV full|right-partial 1 -m64011_220616_211638/15074887/ccs/fwd 2418 Y Y tandem full|right-partial 1 -m64011_220616_211638/15075633/ccs/fwd 2420 Y Y tandem full|right-partial 1 -m64011_220616_211638/15075681/ccs 2110 Y N ssAAV left-partial 2 -m64011_220616_211638/15270333/ccs/fwd 4542 Y Y scAAV right-partial 1 -m64011_220616_211638/15401297/ccs/rev 3429 Y Y scAAV right-partial 1 -m64011_220616_211638/15402156/ccs 2411 Y N ssAAV full 2 -m64011_220616_211638/15403031/ccs 6285 Y Y tandem full|right-partial 1 -m64011_220616_211638/15467889/ccs 2390 Y N ssAAV full 2 -m64011_220616_211638/15532972/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/15534102/ccs/rev 4671 Y Y scAAV full 1 -m64011_220616_211638/15534403/ccs/fwd 4757 Y Y scAAV full 1 -m64011_220616_211638/15728797/ccs 2413 Y Y tandem full|right-partial 1 -m64011_220616_211638/15796487/ccs 3365 Y Y helper NA 1 -m64011_220616_211638/15991668/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/15993319/ccs 3137 Y Y scAAV full 1 -m64011_220616_211638/16058248/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/16058939/ccs 2441 Y N ssAAV full 2 -m64011_220616_211638/16122892/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/16124521/ccs 3896 Y Y scAAV left-partial 1 -m64011_220616_211638/16189032/ccs 2369 Y Y tandem full|right-partial 1 -m64011_220616_211638/16189447/ccs 2642 Y N ssAAV full 2 -m64011_220616_211638/16189601/ccs/fwd 4768 Y Y scAAV full 1 -m64011_220616_211638/16254900/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/16319649/ccs/rev 1936 Y Y scAAV right-partial 1 -m64011_220616_211638/16384554/ccs 4545 Y Y scAAV right-partial 1 -m64011_220616_211638/16386563/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/16516322/ccs 2078 Y N ssAAV left-partial 2 -m64011_220616_211638/16517077/ccs 2412 Y N ssAAV full 2 -m64011_220616_211638/16580890/ccs 2826 Y Y scAAV right-partial 1 -m64011_220616_211638/16581786/ccs 2548 Y Y scAAV left-partial 1 -m64011_220616_211638/16648809/ccs/fwd 4786 Y Y scAAV full 1 -m64011_220616_211638/16778564/ccs 3372 Y Y scAAV right-partial 1 -m64011_220616_211638/16909281/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/16974948/ccs 4970 Y Y scAAV full 1 -m64011_220616_211638/17106254/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/17170669/ccs/rev 1373 Y Y scAAV right-partial 1 -m64011_220616_211638/17173305/ccs/rev 2213 Y N ssAAV right-partial 1 -m64011_220616_211638/17236999/ccs 1138 Y Y tandem left-partial 1 -m64011_220616_211638/17238116/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/17238674/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/17368299/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/17433369/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/17500743/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/17564921/ccs 4871 Y Y scAAV full 1 -m64011_220616_211638/17565898/ccs/rev 2136 Y Y scAAV partial 1 -m64011_220616_211638/17696612/ccs/fwd 2625 Y Y repcap NA 1 -m64011_220616_211638/17826906/ccs 1291 Y N unclassified right-partial 1 -m64011_220616_211638/17827236/ccs 2321 Y N unclassified right-partial 1 -m64011_220616_211638/17892348/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/17892622/ccs/rev 2329 Y Y repcap NA 1 -m64011_220616_211638/17892644/ccs 2104 Y N ssAAV left-partial 2 -m64011_220616_211638/17957383/ccs/rev 3827 Y Y scAAV right-partial 1 -m64011_220616_211638/17958292/ccs 2409 Y Y scAAV full|right-partial 1 -m64011_220616_211638/18025298/ccs 4178 Y Y scAAV full|right-partial 1 -m64011_220616_211638/18220473/ccs 2442 Y N ssAAV full 2 -m64011_220616_211638/18220809/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/18220999/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/18285732/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/18416710/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/18416716/ccs/fwd 1217 Y Y scAAV left-partial 1 -m64011_220616_211638/18417209/ccs 4075 Y Y scAAV left-partial 1 -m64011_220616_211638/18743762/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/18941362/ccs 3492 Y Y scAAV right-partial 1 -m64011_220616_211638/19073372/ccs/rev 4783 Y Y scAAV full 1 -m64011_220616_211638/19138445/ccs/rev 2911 Y Y repcap NA 1 -m64011_220616_211638/19336003/ccs 4790 Y Y scAAV full 1 -m64011_220616_211638/19464779/ccs/fwd 6327 N N NA NA 1 -m64011_220616_211638/19466059/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/19529802/ccs 4679 Y Y scAAV full 1 -m64011_220616_211638/19532133/ccs 4902 Y Y scAAV full 1 -m64011_220616_211638/19595808/ccs/rev 2120 Y N ssAAV left-partial 1 -m64011_220616_211638/19596743/ccs/rev 5015 N N NA NA 1 -m64011_220616_211638/19597195/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/19727348/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/19792104/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/19793154/ccs 4775 Y Y scAAV full 1 -m64011_220616_211638/19793387/ccs/rev 4791 Y Y scAAV full 1 -m64011_220616_211638/19793734/ccs 2389 Y N ssAAV full 2 -m64011_220616_211638/19858602/ccs 2533 Y N ssAAV full 2 -m64011_220616_211638/19858954/ccs 2476 Y N ssAAV full 2 -m64011_220616_211638/19923312/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/19923887/ccs/rev 3956 Y Y scAAV right-partial 1 -m64011_220616_211638/20055268/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/20056895/ccs/fwd 2205 Y N ssAAV right-partial 1 -m64011_220616_211638/20186096/ccs 4697 Y Y scAAV full 1 -m64011_220616_211638/20186839/ccs 3234 Y Y scAAV right-partial 1 -m64011_220616_211638/20252777/ccs 2679 Y Y scAAV full|left-partial 1 -m64011_220616_211638/20317230/ccs 2468 Y N ssAAV full 2 -m64011_220616_211638/20382200/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/20383461/ccs/fwd 4768 Y Y scAAV full 1 -m64011_220616_211638/20448423/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/20515032/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/20515343/ccs/rev 914 Y Y scAAV right-partial 1 -m64011_220616_211638/20515499/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/20515601/ccs 2341 Y N ssAAV left-partial 2 -m64011_220616_211638/20515609/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/20644105/ccs/fwd 1865 Y Y scAAV left-partial 1 -m64011_220616_211638/20645641/ccs/fwd 1033 Y N unclassified right-partial 1 -m64011_220616_211638/20645865/ccs/rev 3294 Y Y scAAV left-partial 1 -m64011_220616_211638/20711899/ccs 2465 Y N ssAAV full 2 -m64011_220616_211638/20775503/ccs/rev 4795 Y Y scAAV full 1 -m64011_220616_211638/20777243/ccs/fwd 4777 Y Y scAAV full 1 -m64011_220616_211638/20841387/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/20972550/ccs 2257 Y N ssAAV right-partial 2 -m64011_220616_211638/21038931/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/21104509/ccs 4773 Y Y scAAV full 1 -m64011_220616_211638/21169369/ccs/rev 4784 Y Y scAAV full 1 -m64011_220616_211638/21170865/ccs 4846 Y Y scAAV full 1 -m64011_220616_211638/21170931/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/21234684/ccs/fwd 4701 Y Y scAAV full 1 -m64011_220616_211638/21234794/ccs 2823 Y Y tandem vector+backbone|left-partial 1 -m64011_220616_211638/21365091/ccs 4777 Y Y scAAV full 1 -m64011_220616_211638/21366797/ccs 2311 Y N ssAAV full 2 -m64011_220616_211638/21366887/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/21431012/ccs/fwd 2450 Y N ssAAV full 1 -m64011_220616_211638/21432590/ccs/fwd 3433 Y Y scAAV right-partial 1 -m64011_220616_211638/21496679/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/21497481/ccs/fwd 3577 Y Y scAAV right-partial 1 -m64011_220616_211638/21563273/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/21759087/ccs 2040 Y N unclassified left-partial 1 -m64011_220616_211638/21760491/ccs/fwd 4707 Y Y scAAV full 1 -m64011_220616_211638/21824285/ccs 6982 Y Y helper NA 1 -m64011_220616_211638/21889757/ccs 2345 Y N ssAAV full 2 -m64011_220616_211638/21956545/ccs 2493 Y N ssAAV full 2 -m64011_220616_211638/22022472/ccs/fwd 4099 Y Y scAAV left-partial 1 -m64011_220616_211638/22088012/ccs/rev 4774 Y Y scAAV full 1 -m64011_220616_211638/22088394/ccs 2474 Y N ssAAV full 2 -m64011_220616_211638/22283740/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/22348282/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/22545624/ccs 2422 Y Y scAAV full|right-partial 1 -m64011_220616_211638/22612235/ccs/rev 3792 Y Y scAAV left-partial 1 -m64011_220616_211638/22612492/ccs 2061 Y Y scAAV left-partial 1 -m64011_220616_211638/22807061/ccs/rev 537 Y Y scAAV right-partial 1 -m64011_220616_211638/22808677/ccs 4679 Y Y scAAV right-partial 1 -m64011_220616_211638/22872306/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/22874108/ccs 4696 Y Y scAAV full 1 -m64011_220616_211638/22938977/ccs 2403 Y Y tandem full|right-partial 1 -m64011_220616_211638/22940217/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/23004300/ccs/fwd 2447 Y Y scAAV right-partial 1 -m64011_220616_211638/23136813/ccs/rev 4784 Y Y scAAV full 1 -m64011_220616_211638/23267905/ccs/rev 3295 Y Y scAAV right-partial 1 -m64011_220616_211638/23398728/ccs/rev 3998 N N NA NA 1 -m64011_220616_211638/23527532/ccs 1007 Y N ssAAV right-partial 2 -m64011_220616_211638/23659243/ccs 2252 Y N ssAAV right-partial 2 -m64011_220616_211638/23659389/ccs 4786 Y Y scAAV full 1 -m64011_220616_211638/23790346/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/23988057/ccs/rev 4908 Y Y scAAV full 1 -m64011_220616_211638/24051956/ccs 2356 Y Y scAAV full|right-partial 1 -m64011_220616_211638/24051973/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/24051988/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/24117628/ccs 2406 Y N ssAAV full 2 -m64011_220616_211638/24250591/ccs 2840 Y Y scAAV left-partial 1 -m64011_220616_211638/24314828/ccs 2441 Y N ssAAV full 2 -m64011_220616_211638/24380197/ccs/rev 4790 Y Y scAAV full 1 -m64011_220616_211638/24445720/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/24512868/ccs 4673 Y Y scAAV full 1 -m64011_220616_211638/24577129/ccs 791 Y Y helper|vector NA|left-partial 1 -m64011_220616_211638/24578271/ccs 2585 Y N ssAAV full 2 -m64011_220616_211638/24707073/ccs/fwd 4804 Y Y scAAV full 1 -m64011_220616_211638/24707287/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/24774378/ccs/fwd 4789 Y Y scAAV full 1 -m64011_220616_211638/24838549/ccs/fwd 4705 Y Y scAAV full 1 -m64011_220616_211638/24840167/ccs/rev 4778 Y Y scAAV full 1 -m64011_220616_211638/24840690/ccs 2484 Y N ssAAV full 2 -m64011_220616_211638/24904521/ccs 3108 Y Y scAAV right-partial 1 -m64011_220616_211638/24906175/ccs 4809 Y Y scAAV full 1 -m64011_220616_211638/24970494/ccs 2160 Y N ssAAV right-partial 2 -m64011_220616_211638/24970883/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/24971601/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/24971660/ccs 4297 Y N unclassified right-partial 1 -m64011_220616_211638/25035807/ccs/fwd 4866 Y Y scAAV full 1 -m64011_220616_211638/25037224/ccs/fwd 5087 Y Y scAAV full 1 -m64011_220616_211638/25101337/ccs 4118 Y Y repcap NA 1 -m64011_220616_211638/25101935/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/25103186/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/25165835/ccs 3784 Y Y scAAV left-partial 1 -m64011_220616_211638/25231603/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/25232482/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/25298628/ccs 4769 Y Y scAAV full 1 -m64011_220616_211638/25298786/ccs 2413 Y N ssAAV full 2 -m64011_220616_211638/25299651/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/25363898/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/25364489/ccs/fwd 891 Y Y scAAV right-partial 1 -m64011_220616_211638/25364489/ccs/rev 892 Y Y scAAV right-partial 1 -m64011_220616_211638/25364675/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/25496245/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/25561487/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/25561685/ccs 3779 Y Y scAAV left-partial 1 -m64011_220616_211638/25627053/ccs/rev 3490 Y Y scAAV right-partial 1 -m64011_220616_211638/25691711/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/25757512/ccs 973 Y Y scAAV right-partial 1 -m64011_220616_211638/25821663/ccs/fwd 4758 Y Y scAAV full 1 -m64011_220616_211638/25823079/ccs/rev 4691 Y Y scAAV full 1 -m64011_220616_211638/26084254/ccs/fwd 1180 Y Y scAAV right-partial 1 -m64011_220616_211638/26084336/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/26084756/ccs/rev 2807 Y Y scAAV right-partial 1 -m64011_220616_211638/26149037/ccs 2968 Y Y scAAV right-partial 1 -m64011_220616_211638/26215557/ccs 2209 Y N ssAAV right-partial 2 -m64011_220616_211638/26281573/ccs 2104 Y N ssAAV right-partial 2 -m64011_220616_211638/26347214/ccs/rev 4811 Y Y scAAV full 1 -m64011_220616_211638/26413072/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/26542748/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/26674465/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/26674704/ccs 2470 Y N ssAAV full 2 -m64011_220616_211638/26675228/ccs/fwd 4735 Y Y scAAV full 1 -m64011_220616_211638/26739666/ccs 1647 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/26805681/ccs 2188 Y N ssAAV left-partial 2 -m64011_220616_211638/26806380/ccs/fwd 3594 Y Y scAAV left-partial 1 -m64011_220616_211638/26870342/ccs/rev 5660 Y Y repcap NA 1 -m64011_220616_211638/26871161/ccs 2133 Y N ssAAV right-partial 2 -m64011_220616_211638/26871672/ccs 3586 Y N unclassified backbone 1 -m64011_220616_211638/26938138/ccs 2431 Y N ssAAV full 2 -m64011_220616_211638/27003622/ccs/fwd 3695 Y Y scAAV full 1 -m64011_220616_211638/27003695/ccs 2433 Y N ssAAV full 2 -m64011_220616_211638/27068293/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/27199943/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/27264238/ccs 2374 Y N ssAAV full 2 -m64011_220616_211638/27265200/ccs 4740 Y Y scAAV full 1 -m64011_220616_211638/27394659/ccs/rev 4741 Y Y scAAV full 1 -m64011_220616_211638/27461949/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/27462092/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/27526676/ccs 5133 Y Y scAAV full 1 -m64011_220616_211638/27657042/ccs 2441 Y N ssAAV full 2 -m64011_220616_211638/27722783/ccs/rev 4771 Y Y scAAV full 1 -m64011_220616_211638/27789270/ccs/fwd 3147 Y N helper NA 1 -m64011_220616_211638/27853859/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/27920676/ccs 2420 Y N ssAAV full 2 -m64011_220616_211638/27984072/ccs/fwd 1917 Y Y scAAV left-partial 1 -m64011_220616_211638/28116718/ccs 4932 Y Y scAAV full 1 -m64011_220616_211638/28313081/ccs 2096 Y Y scAAV partial 1 -m64011_220616_211638/28314242/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/28378673/ccs 1943 Y Y scAAV left-partial|right-partial 1 -m64011_220616_211638/28378795/ccs 4911 Y Y scAAV full 1 -m64011_220616_211638/28379176/ccs/fwd 4987 Y Y helper NA 1 -m64011_220616_211638/28444950/ccs 4776 Y Y scAAV full 1 -m64011_220616_211638/28508959/ccs 5054 Y Y scAAV full 1 -m64011_220616_211638/28509753/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/28574536/ccs/rev 4772 Y Y scAAV full 1 -m64011_220616_211638/28639517/ccs/fwd 2422 Y N ssAAV full 1 -m64011_220616_211638/28772095/ccs 1906 Y Y scAAV right-partial 1 -m64011_220616_211638/28772351/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/28837276/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/28902085/ccs 4476 Y Y scAAV left-partial 1 -m64011_220616_211638/28902562/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/28967507/ccs 2409 Y N ssAAV full 2 -m64011_220616_211638/28968873/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/28968903/ccs/fwd 1453 Y Y scAAV left-partial 1 -m64011_220616_211638/28969090/ccs 2506 Y N ssAAV full 2 -m64011_220616_211638/28969272/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/29033634/ccs 4723 Y Y scAAV full 1 -m64011_220616_211638/29034754/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/29099521/ccs 2410 Y Y scAAV full|right-partial 1 -m64011_220616_211638/29229663/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/29230852/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/29231289/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/29363001/ccs 1056 Y Y scAAV partial 1 -m64011_220616_211638/29427320/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/29427959/ccs 1686 Y N ssAAV left-partial 2 -m64011_220616_211638/29559103/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/29559168/ccs 1003 Y N unclassified right-partial 1 -m64011_220616_211638/29623253/ccs 3943 Y Y scAAV vector+backbone 1 -m64011_220616_211638/29624589/ccs/rev 7544 Y Y repcap NA 1 -m64011_220616_211638/29688778/ccs 4700 Y Y scAAV full 1 -m64011_220616_211638/29688818/ccs/rev 1508 Y Y scAAV partial 1 -m64011_220616_211638/29689203/ccs 1248 Y Y scAAV right-partial 1 -m64011_220616_211638/29690113/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/29690221/ccs 4721 Y Y scAAV full 1 -m64011_220616_211638/29754039/ccs/rev 2969 Y Y scAAV right-partial 1 -m64011_220616_211638/29754188/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/29755816/ccs 2791 Y N ssAAV right-partial 2 -m64011_220616_211638/29821284/ccs 2370 Y Y scAAV full|right-partial 1 -m64011_220616_211638/29821416/ccs 5397 Y N unclassified right-partial 1 -m64011_220616_211638/29951298/ccs/fwd 4698 Y Y scAAV full 1 -m64011_220616_211638/29951793/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/29952488/ccs/rev 6401 Y N host NA 1 -m64011_220616_211638/30016114/ccs/rev 3572 Y Y scAAV right-partial 1 -m64011_220616_211638/30016410/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/30016478/ccs/fwd 2279 Y N ssAAV left-partial 1 -m64011_220616_211638/30081238/ccs 1496 Y N ssAAV left-partial 2 -m64011_220616_211638/30083524/ccs/rev 2451 Y N ssAAV full 1 -m64011_220616_211638/30083614/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/30147777/ccs 2443 Y N ssAAV full 2 -m64011_220616_211638/30148656/ccs/fwd 4909 Y Y scAAV full 1 -m64011_220616_211638/30212980/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/30409277/ccs 2302 Y N ssAAV right-partial 2 -m64011_220616_211638/30474749/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/30475437/ccs/rev 4567 Y Y scAAV left-partial 1 -m64011_220616_211638/30673201/ccs/fwd 1728 Y Y scAAV right-partial 1 -m64011_220616_211638/30737182/ccs/rev 3653 Y Y scAAV right-partial 1 -m64011_220616_211638/30737253/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/30738066/ccs/rev 2414 Y Y tandem full|right-partial 1 -m64011_220616_211638/30738396/ccs/fwd 4761 Y Y scAAV full 1 -m64011_220616_211638/30934285/ccs 1761 Y Y scAAV right-partial 1 -m64011_220616_211638/31064168/ccs 1298 Y N ssAAV right-partial 2 -m64011_220616_211638/31065121/ccs 1380 Y Y scAAV right-partial 1 -m64011_220616_211638/31066048/ccs/fwd 2350 Y N ssAAV right-partial 1 -m64011_220616_211638/31262414/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/31263117/ccs 1656 Y Y scAAV right-partial 1 -m64011_220616_211638/31326567/ccs 3413 Y Y scAAV left-partial 1 -m64011_220616_211638/31392954/ccs 567 Y Y scAAV right-partial 1 -m64011_220616_211638/31393672/ccs 4970 Y Y scAAV full 1 -m64011_220616_211638/31523748/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/31589472/ccs 2413 Y Y tandem full|right-partial 1 -m64011_220616_211638/31654650/ccs 3443 Y Y scAAV right-partial 1 -m64011_220616_211638/31655523/ccs/fwd 1187 Y Y scAAV partial 1 -m64011_220616_211638/31656518/ccs 1617 Y N ssAAV partial 2 -m64011_220616_211638/31656769/ccs 2372 Y N ssAAV full 2 -m64011_220616_211638/31719519/ccs 2475 Y N ssAAV full 2 -m64011_220616_211638/31720202/ccs/rev 1165 Y N unclassified right-partial 1 -m64011_220616_211638/31721132/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/31721986/ccs 4805 Y Y scAAV full 1 -m64011_220616_211638/31787121/ccs 2196 Y Y scAAV right-partial 1 -m64011_220616_211638/31850601/ccs 2526 Y N ssAAV full 2 -m64011_220616_211638/31916563/ccs/rev 4965 Y Y scAAV full 1 -m64011_220616_211638/32047621/ccs 2443 Y N ssAAV full 2 -m64011_220616_211638/32048559/ccs/rev 4778 Y Y scAAV full 1 -m64011_220616_211638/32048738/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/32179299/ccs 4793 Y Y scAAV full 1 -m64011_220616_211638/32376218/ccs 2413 Y N ssAAV full 2 -m64011_220616_211638/32377344/ccs 2342 Y Y tandem full|right-partial 1 -m64011_220616_211638/32442156/ccs 2083 Y N ssAAV right-partial 2 -m64011_220616_211638/32506537/ccs 761 Y N ssAAV left-partial 2 -m64011_220616_211638/32507294/ccs/fwd 2569 Y N ssAAV right-partial 1 -m64011_220616_211638/32573445/ccs 2516 Y N ssAAV right-partial 2 -m64011_220616_211638/32573536/ccs 2211 Y N ssAAV right-partial 2 -m64011_220616_211638/32639705/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/32703595/ccs 1924 Y N ssAAV left-partial 2 -m64011_220616_211638/32705001/ccs/rev 2634 Y Y scAAV right-partial 1 -m64011_220616_211638/32769340/ccs 2542 Y N ssAAV full 2 -m64011_220616_211638/32899594/ccs 4595 Y Y scAAV right-partial|full 1 -m64011_220616_211638/32967013/ccs 2411 Y Y tandem full|right-partial 1 -m64011_220616_211638/33030943/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/33097842/ccs 2403 Y Y scAAV full|right-partial 1 -m64011_220616_211638/33292736/ccs 4723 Y Y scAAV full 1 -m64011_220616_211638/33294530/ccs 2369 Y N ssAAV full 2 -m64011_220616_211638/33359529/ccs/fwd 1629 Y Y scAAV right-partial 1 -m64011_220616_211638/33360049/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/33423546/ccs 2237 Y N ssAAV left-partial 2 -m64011_220616_211638/33424211/ccs/fwd 4651 Y Y scAAV full 1 -m64011_220616_211638/33424703/ccs 4700 Y Y scAAV full 1 -m64011_220616_211638/33488992/ccs/rev 1324 Y Y scAAV left-partial 1 -m64011_220616_211638/33490689/ccs/rev 4782 Y Y scAAV full 1 -m64011_220616_211638/33490694/ccs 4699 Y Y scAAV full 1 -m64011_220616_211638/33555102/ccs/fwd 2457 Y N ssAAV full 1 -m64011_220616_211638/33686195/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/33752114/ccs/rev 4783 Y Y scAAV full 1 -m64011_220616_211638/33753906/ccs 4922 Y Y scAAV full 1 -m64011_220616_211638/33816830/ccs/fwd 1384 Y Y scAAV right-partial 1 -m64011_220616_211638/33817247/ccs 2914 Y Y scAAV backbone 1 -m64011_220616_211638/33819470/ccs 6787 Y Y scAAV full 1 -m64011_220616_211638/33883318/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/33949155/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/34079664/ccs/rev 2404 Y N ssAAV full 1 -m64011_220616_211638/34079733/ccs/rev 2352 Y N ssAAV right-partial 1 -m64011_220616_211638/34275463/ccs/fwd 4787 Y Y scAAV full 1 -m64011_220616_211638/34276466/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/34277231/ccs/rev 4823 Y Y scAAV full 1 -m64011_220616_211638/34277624/ccs 2481 Y N ssAAV full 2 -m64011_220616_211638/34277782/ccs 2213 Y N ssAAV right-partial 2 -m64011_220616_211638/34278169/ccs 2424 Y Y tandem full|right-partial 1 -m64011_220616_211638/34341184/ccs 1075 Y Y scAAV right-partial 1 -m64011_220616_211638/34341732/ccs/rev 1093 Y Y scAAV left-partial 1 -m64011_220616_211638/34406521/ccs/fwd 2409 Y Y tandem full|right-partial 1 -m64011_220616_211638/34407277/ccs/rev 4781 Y Y scAAV full 1 -m64011_220616_211638/34408984/ccs/fwd 3436 Y Y scAAV right-partial 1 -m64011_220616_211638/34473941/ccs/fwd 5525 Y Y repcap NA 1 -m64011_220616_211638/34604142/ccs 2907 Y N ssAAV right-partial 2 -m64011_220616_211638/34605014/ccs 4723 Y Y scAAV full 1 -m64011_220616_211638/34671246/ccs 928 Y Y scAAV left-partial 1 -m64011_220616_211638/34735125/ccs 2217 Y N ssAAV right-partial 2 -m64011_220616_211638/35062994/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/35063825/ccs/fwd 4803 Y Y scAAV full 1 -m64011_220616_211638/35193040/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/35195145/ccs 1918 Y N ssAAV right-partial 2 -m64011_220616_211638/35195381/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/35325785/ccs 3035 Y Y scAAV full|right-partial 1 -m64011_220616_211638/35391515/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/35455005/ccs 1004 Y N ssAAV right-partial 2 -m64011_220616_211638/35455457/ccs 4772 Y Y scAAV full 1 -m64011_220616_211638/35522936/ccs 2440 Y N ssAAV full 2 -m64011_220616_211638/35586142/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/35587332/ccs 6632 Y Y vector|helper full|NA 1 -m64011_220616_211638/35588139/ccs 3982 Y Y scAAV left-partial 1 -m64011_220616_211638/35784158/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/35784597/ccs/fwd 1741 Y N repcap NA 1 -m64011_220616_211638/35850073/ccs 2525 Y N ssAAV right-partial 2 -m64011_220616_211638/35915657/ccs/fwd 2373 Y N ssAAV right-partial 1 -m64011_220616_211638/35979931/ccs 2304 Y N ssAAV right-partial 2 -m64011_220616_211638/36044992/ccs/rev 2452 Y N ssAAV full 1 -m64011_220616_211638/36045442/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/36110954/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/36111736/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/36178110/ccs/fwd 2208 Y N ssAAV right-partial 1 -m64011_220616_211638/36242390/ccs/fwd 4763 Y Y scAAV full 1 -m64011_220616_211638/36309601/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/36372831/ccs 2413 Y Y tandem full|right-partial 1 -m64011_220616_211638/36373139/ccs/fwd 4957 Y Y scAAV full 1 -m64011_220616_211638/36373373/ccs/fwd 4776 Y Y scAAV full 1 -m64011_220616_211638/36374497/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/36375017/ccs 4770 Y Y scAAV full 1 -m64011_220616_211638/36504675/ccs 2398 Y N ssAAV full 2 -m64011_220616_211638/36635733/ccs 2904 Y Y scAAV right-partial 1 -m64011_220616_211638/36700404/ccs 2512 Y N ssAAV full 2 -m64011_220616_211638/36701908/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/36702774/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/36963240/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/36963348/ccs/fwd 4859 Y Y scAAV full 1 -m64011_220616_211638/36963390/ccs/rev 2454 Y N ssAAV full 1 -m64011_220616_211638/36964606/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/37095506/ccs/fwd 4697 Y Y scAAV full 1 -m64011_220616_211638/37159421/ccs 3901 Y Y scAAV left-partial 1 -m64011_220616_211638/37160387/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/37161020/ccs 2429 Y N ssAAV full 2 -m64011_220616_211638/37226055/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/37292165/ccs/fwd 4682 Y Y scAAV full 1 -m64011_220616_211638/37422535/ccs 2389 Y N ssAAV full 2 -m64011_220616_211638/37423731/ccs/rev 2999 Y Y scAAV left-partial 1 -m64011_220616_211638/37487650/ccs 2440 Y N ssAAV full 2 -m64011_220616_211638/37618052/ccs/fwd 4673 Y Y scAAV full 1 -m64011_220616_211638/37619041/ccs/fwd 4800 Y Y scAAV full 1 -m64011_220616_211638/37683781/ccs 2481 Y N ssAAV full 2 -m64011_220616_211638/37685843/ccs 802 Y Y scAAV left-partial|right-partial 1 -m64011_220616_211638/37685903/ccs/rev 2412 Y N ssAAV full 1 -m64011_220616_211638/37750291/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/37751232/ccs/rev 4779 Y Y scAAV full 1 -m64011_220616_211638/38012216/ccs/rev 2357 Y N ssAAV full 1 -m64011_220616_211638/38013201/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/38076741/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/38078719/ccs/fwd 2451 Y N ssAAV full 1 -m64011_220616_211638/38079191/ccs 2162 Y N ssAAV left-partial 2 -m64011_220616_211638/38209409/ccs/fwd 2215 Y N ssAAV right-partial 1 -m64011_220616_211638/38210191/ccs/fwd 2108 Y Y scAAV right-partial 1 -m64011_220616_211638/38275419/ccs/rev 1959 Y Y scAAV right-partial 1 -m64011_220616_211638/38275481/ccs/fwd 356 Y Y scAAV left-partial|right-partial 1 -m64011_220616_211638/38275809/ccs 4697 Y Y scAAV full 1 -m64011_220616_211638/38340089/ccs 2368 Y Y scAAV full|right-partial 1 -m64011_220616_211638/38340897/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/38340944/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/38471806/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/38535570/ccs/rev 2907 Y Y scAAV right-partial 1 -m64011_220616_211638/38600796/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/38798074/ccs/rev 3466 Y Y scAAV partial 1 -m64011_220616_211638/38798750/ccs 4759 Y Y scAAV full 1 -m64011_220616_211638/38799174/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/38929297/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/38929867/ccs/rev 4781 Y Y scAAV full 1 -m64011_220616_211638/38994080/ccs/fwd 1347 Y Y scAAV right-partial 1 -m64011_220616_211638/38995251/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/38995880/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/39126455/ccs/fwd 4787 Y Y scAAV full 1 -m64011_220616_211638/39126792/ccs 2443 Y N ssAAV full 2 -m64011_220616_211638/39192426/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/39192619/ccs 4839 Y Y scAAV full 1 -m64011_220616_211638/39193391/ccs 2412 Y N ssAAV full 2 -m64011_220616_211638/39256356/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/39257120/ccs/fwd 2458 Y N ssAAV full 1 -m64011_220616_211638/39258131/ccs 2384 Y Y tandem full|right-partial 1 -m64011_220616_211638/39323238/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/39389991/ccs/fwd 2452 Y N ssAAV full 1 -m64011_220616_211638/39454127/ccs 4702 Y Y scAAV full 1 -m64011_220616_211638/39519524/ccs/rev 2227 Y N ssAAV right-partial 1 -m64011_220616_211638/39585381/ccs/fwd 3042 Y Y scAAV right-partial 1 -m64011_220616_211638/39650181/ccs 1681 Y N ssAAV right-partial 2 -m64011_220616_211638/39651322/ccs 1428 Y N ssAAV left-partial 2 -m64011_220616_211638/39651605/ccs 2439 Y N ssAAV full 2 -m64011_220616_211638/39847494/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/39912113/ccs 4786 Y Y scAAV full 1 -m64011_220616_211638/39978448/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/39979805/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/40174735/ccs/fwd 4699 Y Y scAAV full 1 -m64011_220616_211638/40175837/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/40239533/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/40240491/ccs/rev 2420 Y N ssAAV full 1 -m64011_220616_211638/40306305/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/40307433/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/40371186/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/40371578/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/40502203/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/40503219/ccs 2909 Y Y scAAV right-partial 1 -m64011_220616_211638/40503821/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/40567741/ccs/rev 4689 Y Y scAAV full 1 -m64011_220616_211638/40567942/ccs 2410 Y Y scAAV full|right-partial 1 -m64011_220616_211638/40633873/ccs/rev 7294 Y Y scAAV vector+backbone 1 -m64011_220616_211638/40634182/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/40764386/ccs/fwd 2453 Y N ssAAV full 1 -m64011_220616_211638/40765042/ccs 6890 Y Y repcap NA 1 -m64011_220616_211638/40831228/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/40895484/ccs/rev 957 Y Y scAAV right-partial 1 -m64011_220616_211638/40896741/ccs 6341 Y Y host NA 1 -m64011_220616_211638/40896778/ccs 2409 Y Y tandem full|right-partial 1 -m64011_220616_211638/40960744/ccs/rev 1503 Y N ssAAV left-partial 1 -m64011_220616_211638/41028261/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/41157716/ccs 4786 Y Y scAAV full 1 -m64011_220616_211638/41158626/ccs 1365 Y Y repcap NA 1 -m64011_220616_211638/41223159/ccs/rev 2440 Y N ssAAV full 1 -m64011_220616_211638/41288572/ccs 1529 Y Y scAAV right-partial 1 -m64011_220616_211638/41290554/ccs 4771 Y Y scAAV full 1 -m64011_220616_211638/41419885/ccs/rev 4696 Y Y scAAV full 1 -m64011_220616_211638/41419915/ccs 4765 Y Y scAAV full 1 -m64011_220616_211638/41419969/ccs 2555 Y Y scAAV full|left-partial 1 -m64011_220616_211638/41420959/ccs/rev 2133 Y N unclassified right-partial 1 -m64011_220616_211638/41484884/ccs 1465 Y Y scAAV left-partial 1 -m64011_220616_211638/41486506/ccs 2613 Y N ssAAV right-partial 2 -m64011_220616_211638/41551356/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/41552717/ccs 2432 Y N ssAAV full 2 -m64011_220616_211638/41617651/ccs 2000 Y N ssAAV left-partial 2 -m64011_220616_211638/41683062/ccs 2369 Y N ssAAV full 2 -m64011_220616_211638/41748778/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/41748974/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/41749256/ccs/fwd 4790 Y Y scAAV full 1 -m64011_220616_211638/41813293/ccs/rev 4738 Y Y scAAV full 1 -m64011_220616_211638/42010040/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/42140156/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/42270853/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/42271817/ccs 4786 Y Y scAAV full 1 -m64011_220616_211638/42338345/ccs 502 Y Y scAAV left-partial 1 -m64011_220616_211638/42402126/ccs 4654 Y Y scAAV full 1 -m64011_220616_211638/42402535/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/42534493/ccs 2425 Y N ssAAV full 2 -m64011_220616_211638/42598611/ccs/fwd 1240 Y Y scAAV right-partial 1 -m64011_220616_211638/42600862/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/42797027/ccs 3422 Y Y scAAV left-partial 1 -m64011_220616_211638/42861004/ccs/fwd 4759 Y Y scAAV full 1 -m64011_220616_211638/42861338/ccs/fwd 4764 Y Y scAAV full 1 -m64011_220616_211638/42927977/ccs 4177 N N NA NA 1 -m64011_220616_211638/42992376/ccs/rev 4777 Y Y scAAV full 1 -m64011_220616_211638/42993567/ccs 2468 Y N ssAAV full 2 -m64011_220616_211638/43123260/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/43254500/ccs 5050 Y Y scAAV full 1 -m64011_220616_211638/43320215/ccs 2304 Y N unclassified right-partial 1 -m64011_220616_211638/43387172/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/43387452/ccs 3798 Y Y helper NA 1 -m64011_220616_211638/43451525/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/43452962/ccs 753 Y Y scAAV partial 1 -m64011_220616_211638/43516528/ccs 4773 Y Y scAAV full 1 -m64011_220616_211638/43517163/ccs/fwd 4763 Y Y scAAV full 1 -m64011_220616_211638/43518142/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/43582514/ccs/fwd 4777 Y Y scAAV full 1 -m64011_220616_211638/43583250/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/43714402/ccs/fwd 2907 Y Y scAAV partial 1 -m64011_220616_211638/43778374/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/43844348/ccs 2356 Y N unclassified right-partial 1 -m64011_220616_211638/43910301/ccs/fwd 1973 Y N ssAAV left-partial 1 -m64011_220616_211638/43977066/ccs 5872 Y Y scAAV full 1 -m64011_220616_211638/44040591/ccs/fwd 4805 Y Y scAAV full 1 -m64011_220616_211638/44041645/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/44107255/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/44108121/ccs 2390 Y Y scAAV left-partial|partial 1 -m64011_220616_211638/44172742/ccs 4636 Y Y scAAV full 1 -m64011_220616_211638/44304313/ccs/fwd 2511 Y Y scAAV left-partial 1 -m64011_220616_211638/44501419/ccs/rev 4679 Y Y scAAV full 1 -m64011_220616_211638/44501539/ccs/fwd 5084 Y Y scAAV full 1 -m64011_220616_211638/44565754/ccs/rev 4787 Y Y scAAV full 1 -m64011_220616_211638/44565831/ccs/rev 5365 N N NA NA 1 -m64011_220616_211638/44566167/ccs 3351 Y Y scAAV partial 1 -m64011_220616_211638/44632541/ccs 4787 Y Y scAAV full 1 -m64011_220616_211638/44696443/ccs 3335 Y Y scAAV right-partial 1 -m64011_220616_211638/44763073/ccs 2433 Y N ssAAV full 2 -m64011_220616_211638/44827015/ccs/rev 4701 Y Y scAAV full 1 -m64011_220616_211638/44828551/ccs/rev 4783 Y Y scAAV full 1 -m64011_220616_211638/44829319/ccs/rev 4700 Y Y scAAV full 1 -m64011_220616_211638/44892703/ccs 2373 Y N ssAAV full 2 -m64011_220616_211638/44893674/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/44894332/ccs/fwd 2449 Y N ssAAV full 1 -m64011_220616_211638/44960276/ccs 2025 Y Y scAAV partial 1 -m64011_220616_211638/44960478/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/45091580/ccs 4678 Y Y scAAV full 1 -m64011_220616_211638/45155170/ccs/fwd 4755 Y Y scAAV full 1 -m64011_220616_211638/45156350/ccs 2489 Y N ssAAV full 2 -m64011_220616_211638/45221085/ccs/fwd 4918 Y Y scAAV full 1 -m64011_220616_211638/45221204/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/45222188/ccs 4705 Y Y scAAV full 1 -m64011_220616_211638/45286557/ccs 2236 Y N ssAAV right-partial 2 -m64011_220616_211638/45352005/ccs 1241 Y Y scAAV right-partial 1 -m64011_220616_211638/45417205/ccs 2275 Y Y scAAV left-partial 1 -m64011_220616_211638/45417754/ccs/rev 2097 Y N ssAAV right-partial 1 -m64011_220616_211638/45418431/ccs 2488 Y N ssAAV full 2 -m64011_220616_211638/45483494/ccs 2410 Y N ssAAV full 2 -m64011_220616_211638/45483771/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/45484072/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/45549790/ccs 2309 Y N ssAAV right-partial 2 -m64011_220616_211638/45613880/ccs 4016 Y Y scAAV left-partial 1 -m64011_220616_211638/45614370/ccs/fwd 4755 Y Y scAAV full 1 -m64011_220616_211638/45614797/ccs/fwd 4543 Y Y scAAV left-partial 1 -m64011_220616_211638/45680479/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/45810059/ccs 2348 Y N ssAAV full 2 -m64011_220616_211638/45811305/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/46007432/ccs 3187 Y Y scAAV left-partial 1 -m64011_220616_211638/46139971/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/46203322/ccs/fwd 4778 Y Y scAAV full 1 -m64011_220616_211638/46203341/ccs 4786 Y Y scAAV full 1 -m64011_220616_211638/46205347/ccs 4801 Y Y scAAV full 1 -m64011_220616_211638/46205714/ccs/fwd 2413 Y Y scAAV full|right-partial 1 -m64011_220616_211638/46269325/ccs 4788 Y Y scAAV full 1 -m64011_220616_211638/46467246/ccs 4768 Y Y scAAV full 1 -m64011_220616_211638/46467569/ccs/fwd 2206 Y N unclassified right-partial 1 -m64011_220616_211638/46661853/ccs 4793 Y Y scAAV full 1 -m64011_220616_211638/46729227/ccs/fwd 4899 Y Y scAAV full 1 -m64011_220616_211638/46794541/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/46794573/ccs/fwd 4725 Y Y scAAV full 1 -m64011_220616_211638/46858763/ccs/fwd 4699 Y Y scAAV full 1 -m64011_220616_211638/46925923/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/46990990/ccs/fwd 4495 Y Y scAAV right-partial 1 -m64011_220616_211638/46991575/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/46991805/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/47317470/ccs 2549 Y N ssAAV full 2 -m64011_220616_211638/47319672/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/47319690/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/47383816/ccs/rev 3946 Y N unclassified right-partial 1 -m64011_220616_211638/47384662/ccs 1323 Y N unclassified right-partial 1 -m64011_220616_211638/47450718/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/47514205/ccs/fwd 3205 Y Y scAAV left-partial 1 -m64011_220616_211638/47515748/ccs 4772 Y Y scAAV full 1 -m64011_220616_211638/47579918/ccs 1313 Y Y scAAV left-partial 1 -m64011_220616_211638/47581057/ccs 2924 Y Y tandem full|right-partial 1 -m64011_220616_211638/47645938/ccs/rev 4716 Y Y scAAV full 1 -m64011_220616_211638/47646155/ccs/fwd 4777 Y Y scAAV full 1 -m64011_220616_211638/47776113/ccs 2288 Y N ssAAV left-partial 2 -m64011_220616_211638/47776730/ccs 2406 Y Y tandem full|right-partial 1 -m64011_220616_211638/47777061/ccs 2410 Y N ssAAV full 2 -m64011_220616_211638/47841637/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/47843498/ccs 3180 Y Y scAAV right-partial 1 -m64011_220616_211638/47908134/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/48038204/ccs 2613 Y Y tandem full|left-partial 1 -m64011_220616_211638/48038955/ccs 4459 Y Y scAAV full 1 -m64011_220616_211638/48039925/ccs 2408 Y Y scAAV full|right-partial 1 -m64011_220616_211638/48040496/ccs 2423 Y Y tandem full|right-partial 1 -m64011_220616_211638/48169847/ccs 1862 Y N ssAAV right-partial 2 -m64011_220616_211638/48170013/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/48236745/ccs/rev 2453 Y N ssAAV full 1 -m64011_220616_211638/48236889/ccs/rev 4019 Y Y scAAV left-partial 1 -m64011_220616_211638/48301607/ccs/fwd 4699 Y Y scAAV full 1 -m64011_220616_211638/48302036/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/48366220/ccs 2666 Y N ssAAV full 2 -m64011_220616_211638/48368021/ccs/fwd 2370 Y N ssAAV full 1 -m64011_220616_211638/48368102/ccs/rev 2427 Y Y tandem full|right-partial 1 -m64011_220616_211638/48497104/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/48497342/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/48498976/ccs/fwd 4922 Y Y scAAV full 1 -m64011_220616_211638/48499026/ccs/rev 4844 Y Y scAAV full 1 -m64011_220616_211638/48562466/ccs/fwd 4761 Y Y scAAV full 1 -m64011_220616_211638/48564781/ccs/fwd 3573 Y Y scAAV right-partial 1 -m64011_220616_211638/48693810/ccs 2472 Y N ssAAV full 2 -m64011_220616_211638/48760711/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/48824982/ccs/rev 4782 Y Y scAAV full 1 -m64011_220616_211638/48825130/ccs/rev 3528 Y Y scAAV right-partial 1 -m64011_220616_211638/48826272/ccs 2423 Y N ssAAV full 2 -m64011_220616_211638/48890958/ccs 584 Y Y scAAV right-partial 1 -m64011_220616_211638/48891286/ccs/rev 4768 Y Y scAAV full 1 -m64011_220616_211638/48891785/ccs 4767 Y Y scAAV full 1 -m64011_220616_211638/48956844/ccs 4712 Y Y scAAV full 1 -m64011_220616_211638/49022841/ccs/fwd 2447 Y N ssAAV full 1 -m64011_220616_211638/49152836/ccs 2442 Y N ssAAV full 2 -m64011_220616_211638/49153493/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/49219767/ccs 2427 Y N ssAAV full 2 -m64011_220616_211638/49219778/ccs 2386 Y Y tandem full|right-partial 1 -m64011_220616_211638/49414267/ccs/rev 4759 Y Y scAAV full 1 -m64011_220616_211638/49416618/ccs 2364 Y N ssAAV full 2 -m64011_220616_211638/49479935/ccs/rev 4777 Y Y scAAV full 1 -m64011_220616_211638/49481336/ccs 4995 Y Y scAAV full 1 -m64011_220616_211638/49743287/ccs/fwd 4776 Y Y scAAV full 1 -m64011_220616_211638/49808501/ccs 1757 Y Y scAAV right-partial 1 -m64011_220616_211638/49875792/ccs 1352 Y Y scAAV right-partial 1 -m64011_220616_211638/49938648/ccs 4689 Y Y scAAV full 1 -m64011_220616_211638/50070185/ccs 5884 Y Y scAAV full 1 -m64011_220616_211638/50070753/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/50135340/ccs 4676 Y Y scAAV full 1 -m64011_220616_211638/50137780/ccs/fwd 4712 Y Y scAAV right-partial 1 -m64011_220616_211638/50266877/ccs/fwd 4721 Y Y scAAV full 1 -m64011_220616_211638/50266991/ccs 1771 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/50268739/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/50332559/ccs/rev 4781 Y Y scAAV full 1 -m64011_220616_211638/50333251/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/50399233/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/50465239/ccs/fwd 9422 Y Y repcap NA 1 -m64011_220616_211638/50530166/ccs 2407 Y N ssAAV full 2 -m64011_220616_211638/50660580/ccs 536 Y Y scAAV right-partial 1 -m64011_220616_211638/50662020/ccs/rev 2411 Y N ssAAV full 1 -m64011_220616_211638/50725855/ccs 1198 Y N ssAAV right-partial 2 -m64011_220616_211638/50790511/ccs/fwd 1279 Y N ssAAV right-partial 1 -m64011_220616_211638/50856684/ccs 4775 Y Y scAAV full 1 -m64011_220616_211638/50858572/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/50922237/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/50987980/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/51250695/ccs 2388 Y Y tandem full|right-partial 1 -m64011_220616_211638/51251318/ccs 2369 Y N ssAAV full 2 -m64011_220616_211638/51381795/ccs/fwd 4412 Y Y scAAV left-partial 1 -m64011_220616_211638/51382837/ccs 2370 Y Y scAAV full|right-partial 1 -m64011_220616_211638/51445921/ccs 4468 Y Y scAAV right-partial 1 -m64011_220616_211638/51448401/ccs 2409 Y N ssAAV full 2 -m64011_220616_211638/51512131/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/51512190/ccs 3381 Y Y scAAV right-partial 1 -m64011_220616_211638/51709032/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/51776190/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/51840944/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/51841471/ccs 4765 Y Y scAAV full 1 -m64011_220616_211638/51905260/ccs/rev 4785 Y Y scAAV full 1 -m64011_220616_211638/51905945/ccs/rev 4787 Y Y scAAV full 1 -m64011_220616_211638/51907321/ccs 2369 Y Y scAAV full|right-partial 1 -m64011_220616_211638/51971247/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/51971811/ccs 4761 Y Y scAAV full 1 -m64011_220616_211638/52038490/ccs/fwd 1385 Y Y scAAV right-partial 1 -m64011_220616_211638/52167635/ccs 3041 Y Y scAAV right-partial 1 -m64011_220616_211638/52233221/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/52233461/ccs 2387 Y N ssAAV full 2 -m64011_220616_211638/52233526/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/52233539/ccs/fwd 2927 Y Y scAAV right-partial 1 -m64011_220616_211638/52363932/ccs 4813 Y Y scAAV full 1 -m64011_220616_211638/52364148/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/52365887/ccs 2392 Y Y scAAV right-partial 1 -m64011_220616_211638/52429139/ccs 2464 Y N ssAAV full 2 -m64011_220616_211638/52495376/ccs/rev 2310 Y Y helper|vector NA|right-partial 1 -m64011_220616_211638/52496040/ccs/fwd 4991 Y Y scAAV full 1 -m64011_220616_211638/52561491/ccs/rev 2205 Y N ssAAV right-partial 1 -m64011_220616_211638/52562150/ccs 1170 Y N ssAAV right-partial 2 -m64011_220616_211638/52627535/ccs/fwd 2107 Y Y scAAV partial 1 -m64011_220616_211638/52691456/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/52693386/ccs 2441 Y N ssAAV full 2 -m64011_220616_211638/52758299/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/52822953/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/52823145/ccs 2409 Y N ssAAV full 2 -m64011_220616_211638/52823376/ccs 2406 Y Y scAAV full|right-partial 1 -m64011_220616_211638/52824199/ccs 2410 Y Y scAAV full|right-partial 1 -m64011_220616_211638/52955168/ccs 2215 Y N ssAAV right-partial 2 -m64011_220616_211638/53018700/ccs/fwd 4765 Y Y scAAV full 1 -m64011_220616_211638/53018921/ccs 2369 Y N ssAAV full 2 -m64011_220616_211638/53151778/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/53216312/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/53281766/ccs 1237 Y Y scAAV right-partial 1 -m64011_220616_211638/53283239/ccs 4835 Y Y scAAV full 1 -m64011_220616_211638/53346780/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/53348147/ccs 2441 Y N ssAAV full 2 -m64011_220616_211638/53348410/ccs 2439 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/53412811/ccs/rev 1898 Y Y scAAV right-partial 1 -m64011_220616_211638/53413272/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/53413775/ccs 2383 Y Y scAAV full|right-partial 1 -m64011_220616_211638/53477909/ccs/rev 2453 Y N ssAAV full 1 -m64011_220616_211638/53544624/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/53608963/ccs 2432 Y N ssAAV full 2 -m64011_220616_211638/53608968/ccs 4921 Y Y scAAV full 1 -m64011_220616_211638/53611327/ccs/rev 4744 Y Y scAAV full 1 -m64011_220616_211638/53674633/ccs 2411 Y Y tandem full|right-partial 1 -m64011_220616_211638/53676187/ccs/fwd 4779 Y Y scAAV full 1 -m64011_220616_211638/53807474/ccs 544 Y N ssAAV partial 2 -m64011_220616_211638/53870868/ccs 2474 Y N ssAAV full 2 -m64011_220616_211638/54068369/ccs 4748 Y Y scAAV full 1 -m64011_220616_211638/54133339/ccs/rev 981 Y Y scAAV partial 1 -m64011_220616_211638/54199759/ccs/rev 2388 Y N ssAAV full 1 -m64011_220616_211638/54263867/ccs 2051 Y Y repcap NA 1 -m64011_220616_211638/54266214/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/54332215/ccs/rev 2621 Y Y scAAV right-partial 1 -m64011_220616_211638/54395948/ccs/rev 3981 Y Y scAAV left-partial 1 -m64011_220616_211638/54396066/ccs/fwd 2906 Y N ssAAV right-partial 1 -m64011_220616_211638/54397090/ccs/fwd 4771 Y Y scAAV full 1 -m64011_220616_211638/54397139/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/54460782/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/54527636/ccs 5261 Y Y scAAV full 1 -m64011_220616_211638/54591723/ccs 3955 Y Y scAAV right-partial 1 -m64011_220616_211638/54592446/ccs 2491 Y N ssAAV full 2 -m64011_220616_211638/54723964/ccs/rev 4683 Y Y scAAV full 1 -m64011_220616_211638/54789492/ccs 2251 Y N ssAAV right-partial 2 -m64011_220616_211638/54790709/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/54855937/ccs 2383 Y N ssAAV full 2 -m64011_220616_211638/54987202/ccs/rev 4693 Y Y scAAV full 1 -m64011_220616_211638/55051376/ccs 2373 Y N ssAAV full 2 -m64011_220616_211638/55051611/ccs/rev 2447 Y N ssAAV full 1 -m64011_220616_211638/55115925/ccs 2424 Y Y tandem full|right-partial 1 -m64011_220616_211638/55183384/ccs 4701 Y Y scAAV full 1 -m64011_220616_211638/55248099/ccs/fwd 4626 Y Y scAAV full 1 -m64011_220616_211638/55248228/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/55249269/ccs 4648 Y Y scAAV full 1 -m64011_220616_211638/55378914/ccs 1958 Y N ssAAV right-partial 2 -m64011_220616_211638/55446029/ccs 4341 Y Y scAAV right-partial 1 -m64011_220616_211638/55510005/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/55510261/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/55510552/ccs/fwd 4701 Y Y scAAV full 1 -m64011_220616_211638/55575208/ccs 4810 Y Y scAAV full 1 -m64011_220616_211638/55836691/ccs/rev 1479 Y Y scAAV left-partial 1 -m64011_220616_211638/55902802/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/55903342/ccs/fwd 2451 Y N ssAAV full 1 -m64011_220616_211638/55904604/ccs/rev 4696 Y Y scAAV full 1 -m64011_220616_211638/55970165/ccs/rev 2417 Y N ssAAV full 1 -m64011_220616_211638/56033284/ccs/fwd 2236 Y Y scAAV left-partial 1 -m64011_220616_211638/56034165/ccs 1401 Y N ssAAV right-partial 2 -m64011_220616_211638/56035904/ccs 2790 Y N ssAAV right-partial 2 -m64011_220616_211638/56165832/ccs 4686 Y Y scAAV full 1 -m64011_220616_211638/56166992/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/56230991/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/56232522/ccs 1239 Y Y scAAV right-partial 1 -m64011_220616_211638/56295858/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/56297278/ccs 2472 Y N ssAAV full 2 -m64011_220616_211638/56361071/ccs/fwd 3049 Y Y scAAV left-partial 1 -m64011_220616_211638/56362322/ccs/rev 2207 Y Y tandem right-partial 1 -m64011_220616_211638/56363000/ccs 2224 Y Y tandem partial|left-partial 1 -m64011_220616_211638/56363011/ccs 1972 Y N ssAAV left-partial 2 -m64011_220616_211638/56363434/ccs 3355 Y Y scAAV right-partial 1 -m64011_220616_211638/56427852/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/56494835/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/56557773/ccs/fwd 3492 Y Y scAAV right-partial 1 -m64011_220616_211638/56623904/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/56625195/ccs/rev 2323 Y N ssAAV right-partial 1 -m64011_220616_211638/56754551/ccs/fwd 5474 Y Y repcap NA 1 -m64011_220616_211638/56756305/ccs/fwd 4712 Y Y scAAV full 1 -m64011_220616_211638/56822104/ccs/rev 2455 Y N ssAAV full 1 -m64011_220616_211638/56887822/ccs/fwd 4680 Y Y scAAV full 1 -m64011_220616_211638/56888146/ccs/fwd 2794 Y Y scAAV left-partial 1 -m64011_220616_211638/56951851/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/56952002/ccs 4769 Y Y scAAV full 1 -m64011_220616_211638/56952491/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/57016862/ccs 5729 Y Y tandem full|right-partial 1 -m64011_220616_211638/57019126/ccs 4108 Y Y scAAV left-partial 1 -m64011_220616_211638/57019160/ccs 2363 Y N ssAAV full 2 -m64011_220616_211638/57083637/ccs/fwd 4775 Y Y scAAV full 1 -m64011_220616_211638/57148117/ccs 4702 Y Y scAAV full 1 -m64011_220616_211638/57148465/ccs 1956 Y N ssAAV right-partial 2 -m64011_220616_211638/57148896/ccs 4699 Y Y scAAV full 1 -m64011_220616_211638/57214429/ccs 1105 Y Y scAAV right-partial 1 -m64011_220616_211638/57214435/ccs/rev 839 Y N ssAAV left-partial 1 -m64011_220616_211638/57214485/ccs/rev 1395 Y N ssAAV right-partial 1 -m64011_220616_211638/57280729/ccs/rev 4926 Y Y scAAV full 1 -m64011_220616_211638/57344005/ccs 1569 Y N ssAAV left-partial 2 -m64011_220616_211638/57344255/ccs 1557 Y Y scAAV left-partial 1 -m64011_220616_211638/57345599/ccs 4586 Y Y scAAV full 1 -m64011_220616_211638/57346036/ccs/fwd 2572 Y Y scAAV right-partial 1 -m64011_220616_211638/57410795/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/57476154/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/57477710/ccs/fwd 2782 Y Y scAAV right-partial 1 -m64011_220616_211638/57540960/ccs 2047 Y Y scAAV partial 1 -m64011_220616_211638/57542569/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/57608095/ccs 4048 Y Y scAAV backbone 1 -m64011_220616_211638/57738773/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/57869848/ccs 4777 Y Y scAAV full 1 -m64011_220616_211638/57871160/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/57935585/ccs 2060 Y Y scAAV right-partial 1 -m64011_220616_211638/57935622/ccs 2387 Y N ssAAV full 2 -m64011_220616_211638/58000754/ccs/rev 4699 Y Y scAAV full 1 -m64011_220616_211638/58065545/ccs 1643 Y Y scAAV right-partial 1 -m64011_220616_211638/58066449/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/58131551/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/58262176/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/58263147/ccs 4787 Y Y scAAV full 1 -m64011_220616_211638/58327802/ccs/fwd 4721 Y Y scAAV full 1 -m64011_220616_211638/58328186/ccs 2170 Y Y tandem right-partial 1 -m64011_220616_211638/58328882/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/58329418/ccs 807 Y Y scAAV partial 1 -m64011_220616_211638/58394103/ccs/fwd 4699 Y Y scAAV full 1 -m64011_220616_211638/58394498/ccs 2481 Y N ssAAV full 2 -m64011_220616_211638/58460916/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/58591205/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/58720620/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/58916949/ccs/rev 1124 Y Y scAAV right-partial 1 -m64011_220616_211638/58918627/ccs 4917 Y Y scAAV full 1 -m64011_220616_211638/58984261/ccs 2423 Y N ssAAV full 2 -m64011_220616_211638/59048362/ccs/rev 1898 Y N ssAAV left-partial 1 -m64011_220616_211638/59048431/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/59115021/ccs/rev 1774 Y Y scAAV right-partial 1 -m64011_220616_211638/59115030/ccs 4769 Y Y scAAV full 1 -m64011_220616_211638/59180374/ccs 1325 Y N ssAAV left-partial 2 -m64011_220616_211638/59180557/ccs 2867 Y Y scAAV right-partial 1 -m64011_220616_211638/59245248/ccs/fwd 4785 Y Y scAAV full 1 -m64011_220616_211638/59378196/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/59441944/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/59443089/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/59572759/ccs 1542 Y N ssAAV left-partial 2 -m64011_220616_211638/59572971/ccs 1964 Y N ssAAV left-partial 2 -m64011_220616_211638/59573999/ccs/fwd 4772 Y Y scAAV full 1 -m64011_220616_211638/59574810/ccs 2498 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/59770120/ccs 4794 Y Y scAAV full 1 -m64011_220616_211638/59836111/ccs 2549 Y N ssAAV right-partial 2 -m64011_220616_211638/59836233/ccs 2313 Y N ssAAV full 2 -m64011_220616_211638/59965988/ccs 1943 Y N ssAAV left-partial 2 -m64011_220616_211638/60032801/ccs 4495 Y Y scAAV full 1 -m64011_220616_211638/60033519/ccs 4796 Y Y scAAV full 1 -m64011_220616_211638/60164638/ccs 1267 Y Y scAAV right-partial 1 -m64011_220616_211638/60228672/ccs 4769 Y Y scAAV full 1 -m64011_220616_211638/60358708/ccs/fwd 4777 Y Y scAAV full 1 -m64011_220616_211638/60359386/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/60425150/ccs 4701 Y Y scAAV full 1 -m64011_220616_211638/60425789/ccs 5046 Y N helper NA 1 -m64011_220616_211638/60426967/ccs 4764 Y Y scAAV full 1 -m64011_220616_211638/60490350/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/60490919/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/60686936/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/60883455/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/60885837/ccs/rev 4760 Y Y scAAV full 1 -m64011_220616_211638/61014035/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/61014296/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/61080303/ccs/fwd 4724 Y Y scAAV full 1 -m64011_220616_211638/61081810/ccs/fwd 2107 Y N ssAAV left-partial 1 -m64011_220616_211638/61146573/ccs 2307 Y N ssAAV left-partial 2 -m64011_220616_211638/61212746/ccs 2414 Y Y tandem full|right-partial 1 -m64011_220616_211638/61277081/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/61343747/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/61409042/ccs/fwd 4776 Y Y scAAV full 1 -m64011_220616_211638/61474790/ccs 1796 Y Y scAAV partial 1 -m64011_220616_211638/61540325/ccs 2464 Y N ssAAV full 2 -m64011_220616_211638/61670552/ccs/rev 4779 Y Y scAAV full 1 -m64011_220616_211638/61735805/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/61737051/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/61803258/ccs/fwd 4767 Y Y scAAV full 1 -m64011_220616_211638/61932920/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/61933368/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/61997553/ccs 2374 Y N ssAAV full 2 -m64011_220616_211638/61999015/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/62064637/ccs 2390 Y N ssAAV full 2 -m64011_220616_211638/62128409/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/62129788/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/62194133/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/62260314/ccs/rev 2454 Y N ssAAV full 1 -m64011_220616_211638/62261379/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/62261496/ccs 2215 Y N ssAAV right-partial 2 -m64011_220616_211638/62326651/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/62391733/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/62458326/ccs/rev 4720 Y Y scAAV full 1 -m64011_220616_211638/62521974/ccs 4773 Y Y scAAV full 1 -m64011_220616_211638/62586943/ccs 1016 Y Y scAAV left-partial 1 -m64011_220616_211638/62652952/ccs/fwd 4684 Y Y scAAV full 1 -m64011_220616_211638/62718282/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/62718400/ccs 2515 Y N ssAAV full 2 -m64011_220616_211638/62719394/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/62786009/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/62786028/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/62916969/ccs 2428 Y N ssAAV full 2 -m64011_220616_211638/62980238/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/62981281/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/62981459/ccs 4698 Y Y scAAV full 1 -m64011_220616_211638/63047953/ccs 2653 Y Y scAAV full|left-partial 1 -m64011_220616_211638/63177112/ccs 2708 Y Y tandem full|left-partial 1 -m64011_220616_211638/63178089/ccs 2212 Y N ssAAV right-partial 2 -m64011_220616_211638/63308199/ccs 2349 Y Y scAAV full|left-partial 1 -m64011_220616_211638/63308340/ccs 2978 Y Y scAAV right-partial 1 -m64011_220616_211638/63310157/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/63373772/ccs 3447 Y Y scAAV right-partial 1 -m64011_220616_211638/63440119/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/63505234/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/63506463/ccs 2390 Y N ssAAV full 2 -m64011_220616_211638/63506723/ccs 2425 Y Y tandem full|right-partial 1 -m64011_220616_211638/63572273/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/63636351/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/63636997/ccs/fwd 2872 Y Y scAAV right-partial 1 -m64011_220616_211638/63637064/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/63702711/ccs 3477 N N NA NA 1 -m64011_220616_211638/63769080/ccs 2474 Y N ssAAV full 2 -m64011_220616_211638/63769089/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/63832714/ccs 3363 Y Y scAAV right-partial 1 -m64011_220616_211638/63833521/ccs/fwd 2455 Y N ssAAV full 1 -m64011_220616_211638/63833884/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/63834589/ccs/fwd 2618 Y N ssAAV right-partial 1 -m64011_220616_211638/63899073/ccs 1378 Y Y scAAV right-partial 1 -m64011_220616_211638/63899170/ccs 4660 Y Y scAAV full 1 -m64011_220616_211638/63899613/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/63963754/ccs/rev 573 Y Y scAAV right-partial 1 -m64011_220616_211638/63964044/ccs/rev 2410 Y Y tandem full|right-partial 1 -m64011_220616_211638/63966008/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/64030571/ccs 3037 Y Y scAAV right-partial 1 -m64011_220616_211638/64030847/ccs 4698 Y Y scAAV full 1 -m64011_220616_211638/64160391/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/64226485/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/64228034/ccs/rev 3256 Y Y scAAV right-partial 1 -m64011_220616_211638/64292270/ccs 2469 Y Y scAAV full|right-partial 1 -m64011_220616_211638/64292696/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/64553390/ccs/fwd 1003 Y N unclassified right-partial 1 -m64011_220616_211638/64553508/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/64619017/ccs/fwd 4775 Y Y scAAV full 1 -m64011_220616_211638/64750807/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/64816471/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/64817081/ccs 3439 Y Y scAAV right-partial 1 -m64011_220616_211638/64881338/ccs/rev 3932 Y Y scAAV right-partial 1 -m64011_220616_211638/64881757/ccs/rev 4464 Y Y scAAV right-partial 1 -m64011_220616_211638/64881918/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/64882940/ccs 2295 Y N ssAAV left-partial 2 -m64011_220616_211638/64947140/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/65013032/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/65078011/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/65078043/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/65078971/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/65144030/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/65209647/ccs 2583 Y N ssAAV full 2 -m64011_220616_211638/65276577/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/65340072/ccs 2423 Y Y tandem full|right-partial 1 -m64011_220616_211638/65470839/ccs/fwd 4645 Y Y scAAV full 1 -m64011_220616_211638/65471100/ccs 2726 Y N ssAAV full 2 -m64011_220616_211638/65471234/ccs/fwd 3436 Y Y scAAV right-partial 1 -m64011_220616_211638/65472682/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/65473258/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/65536790/ccs 2400 Y N ssAAV full 2 -m64011_220616_211638/65537696/ccs 2899 Y Y scAAV left-partial 1 -m64011_220616_211638/65538101/ccs/rev 4787 Y Y scAAV full 1 -m64011_220616_211638/65602440/ccs/rev 4697 Y Y scAAV full 1 -m64011_220616_211638/65602835/ccs/rev 4739 Y Y scAAV full 1 -m64011_220616_211638/65864563/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/65864607/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/65865419/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/65930295/ccs 2195 Y Y scAAV partial 1 -m64011_220616_211638/65930901/ccs/fwd 3406 Y Y scAAV right-partial 1 -m64011_220616_211638/66127008/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/66257952/ccs/rev 4776 Y Y scAAV full 1 -m64011_220616_211638/66258144/ccs/fwd 2452 Y N ssAAV full 1 -m64011_220616_211638/66258319/ccs/rev 4772 Y Y scAAV full 1 -m64011_220616_211638/66455785/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/66455845/ccs 2406 Y Y scAAV full|right-partial 1 -m64011_220616_211638/66456101/ccs 1989 Y Y scAAV right-partial 1 -m64011_220616_211638/66585322/ccs 2807 Y N ssAAV left-partial 2 -m64011_220616_211638/66586902/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/66586959/ccs 4863 Y Y scAAV full|right-partial 1 -m64011_220616_211638/66650448/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/66651349/ccs 4823 Y Y scAAV full 1 -m64011_220616_211638/66651845/ccs/rev 4776 Y Y scAAV full 1 -m64011_220616_211638/66716468/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/66716808/ccs/fwd 1765 Y Y scAAV left-partial 1 -m64011_220616_211638/66848112/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/66849095/ccs 2439 Y N ssAAV full 2 -m64011_220616_211638/66915081/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/66980131/ccs/fwd 2452 Y N ssAAV full 1 -m64011_220616_211638/66980407/ccs 4701 Y Y scAAV full 1 -m64011_220616_211638/67043666/ccs 2873 Y N ssAAV right-partial 2 -m64011_220616_211638/67044093/ccs 2500 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/67044820/ccs/rev 4771 Y Y scAAV full 1 -m64011_220616_211638/67045495/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/67109185/ccs 4787 Y Y scAAV full 1 -m64011_220616_211638/67109380/ccs/rev 1379 Y N unclassified right-partial 1 -m64011_220616_211638/67111345/ccs/rev 4778 Y Y scAAV full 1 -m64011_220616_211638/67177177/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/67241466/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/67242620/ccs 6043 Y Y scAAV full|left-partial 1 -m64011_220616_211638/67242745/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/67306108/ccs/rev 4720 Y Y scAAV full 1 -m64011_220616_211638/67307755/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/67436932/ccs/rev 2265 Y N unclassified left-partial 1 -m64011_220616_211638/67437993/ccs/fwd 4701 Y Y scAAV full 1 -m64011_220616_211638/67439049/ccs/rev 4794 Y Y scAAV full 1 -m64011_220616_211638/67504061/ccs 900 Y Y scAAV right-partial 1 -m64011_220616_211638/67568155/ccs/fwd 2419 Y Y tandem full|right-partial 1 -m64011_220616_211638/67633877/ccs 4766 Y Y scAAV full 1 -m64011_220616_211638/67700440/ccs 3511 Y Y scAAV left-partial 1 -m64011_220616_211638/67830819/ccs/fwd 1178 Y Y scAAV partial 1 -m64011_220616_211638/67961255/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/68093018/ccs/fwd 4693 Y Y scAAV full 1 -m64011_220616_211638/68157553/ccs 3564 Y N helper NA 1 -m64011_220616_211638/68224225/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/68288640/ccs/rev 4694 Y Y scAAV full 1 -m64011_220616_211638/68290016/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/68486088/ccs/rev 4752 Y Y scAAV full 1 -m64011_220616_211638/68551287/ccs 4566 Y Y scAAV full 1 -m64011_220616_211638/68551853/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/68552089/ccs 1026 Y Y scAAV right-partial 1 -m64011_220616_211638/68618965/ccs/rev 4722 Y Y scAAV right-partial 1 -m64011_220616_211638/68683693/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/68747980/ccs/rev 937 Y N unclassified right-partial 1 -m64011_220616_211638/68813599/ccs 2711 Y Y tandem full|left-partial 1 -m64011_220616_211638/68880887/ccs/fwd 2451 Y N ssAAV full 1 -m64011_220616_211638/68943945/ccs 2466 Y N ssAAV full 2 -m64011_220616_211638/68946064/ccs/fwd 4761 Y Y scAAV full 1 -m64011_220616_211638/69208453/ccs/fwd 2441 Y N ssAAV full 1 -m64011_220616_211638/69402693/ccs/fwd 2535 Y Y scAAV left-partial|partial 1 -m64011_220616_211638/69469870/ccs/rev 4799 Y Y scAAV full 1 -m64011_220616_211638/69533706/ccs 1982 Y N ssAAV left-partial 2 -m64011_220616_211638/69534885/ccs/rev 2453 Y N ssAAV full 1 -m64011_220616_211638/69665404/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/69666116/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/69730737/ccs 2386 Y N ssAAV full 2 -m64011_220616_211638/69732188/ccs/fwd 5518 Y N helper NA 1 -m64011_220616_211638/69732827/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/69796045/ccs 4795 Y Y scAAV full 1 -m64011_220616_211638/69798655/ccs/rev 4706 Y Y scAAV full 1 -m64011_220616_211638/69862350/ccs 1541 Y Y scAAV partial 1 -m64011_220616_211638/69862815/ccs 1864 Y Y scAAV partial 1 -m64011_220616_211638/69864135/ccs 1557 Y Y scAAV right-partial 1 -m64011_220616_211638/69993286/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/69993495/ccs 2413 Y N ssAAV full 2 -m64011_220616_211638/69995069/ccs 2446 Y N ssAAV full 2 -m64011_220616_211638/70059386/ccs 1214 Y Y scAAV right-partial 1 -m64011_220616_211638/70124322/ccs/fwd 2354 Y Y scAAV left-partial 1 -m64011_220616_211638/70125834/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/70126253/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/70189958/ccs/rev 4772 Y Y scAAV full 1 -m64011_220616_211638/70191304/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/70191939/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/70321730/ccs 2409 Y N ssAAV full 2 -m64011_220616_211638/70322287/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/70583231/ccs/fwd 5779 Y Y host NA 1 -m64011_220616_211638/70584735/ccs/fwd 4777 Y Y scAAV full 1 -m64011_220616_211638/70647837/ccs 4875 Y Y scAAV full 1 -m64011_220616_211638/70649952/ccs 2821 Y Y scAAV full|left-partial 1 -m64011_220616_211638/70714405/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/70715409/ccs/fwd 2419 Y N ssAAV full 1 -m64011_220616_211638/70715717/ccs 3423 Y Y scAAV right-partial 1 -m64011_220616_211638/70780321/ccs 2481 Y N ssAAV full 2 -m64011_220616_211638/70780600/ccs/rev 3952 Y Y scAAV right-partial 1 -m64011_220616_211638/70781386/ccs 685 Y Y scAAV right-partial 1 -m64011_220616_211638/70911385/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/70975612/ccs 2370 Y Y scAAV full|right-partial 1 -m64011_220616_211638/71041918/ccs/rev 4042 Y Y scAAV left-partial 1 -m64011_220616_211638/71108764/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/71172875/ccs 4656 Y Y scAAV full 1 -m64011_220616_211638/71239744/ccs/fwd 3718 Y Y scAAV left-partial 1 -m64011_220616_211638/71240055/ccs/fwd 4789 Y Y scAAV full 1 -m64011_220616_211638/71304910/ccs/rev 4681 N N NA NA 1 -m64011_220616_211638/71370100/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/71371362/ccs/rev 1857 Y Y scAAV left-partial 1 -m64011_220616_211638/71435786/ccs/rev 2452 Y N ssAAV full 1 -m64011_220616_211638/71436133/ccs/fwd 4743 Y Y scAAV full 1 -m64011_220616_211638/71502103/ccs/fwd 4863 Y Y scAAV full 1 -m64011_220616_211638/71566147/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/71566566/ccs 2441 Y N ssAAV full 2 -m64011_220616_211638/71696607/ccs 4766 Y Y scAAV full 1 -m64011_220616_211638/71698826/ccs/rev 2907 Y Y scAAV right-partial 1 -m64011_220616_211638/71764658/ccs/rev 2621 Y Y scAAV left-partial 1 -m64011_220616_211638/71829749/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/71829944/ccs/fwd 4692 Y Y scAAV full 1 -m64011_220616_211638/71830208/ccs/fwd 4135 Y Y scAAV left-partial 1 -m64011_220616_211638/71959091/ccs 4755 Y Y scAAV full 1 -m64011_220616_211638/71960128/ccs/fwd 7597 Y Y repcap NA 1 -m64011_220616_211638/71961362/ccs/rev 4784 Y Y scAAV full 1 -m64011_220616_211638/72024723/ccs 3153 Y Y tandem full|right-partial 1 -m64011_220616_211638/72157213/ccs 8647 Y Y repcap NA 1 -m64011_220616_211638/72221024/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/72222181/ccs 2191 Y N ssAAV right-partial 2 -m64011_220616_211638/72287770/ccs 2418 Y N ssAAV full 2 -m64011_220616_211638/72288961/ccs/rev 4136 Y Y scAAV right-partial 1 -m64011_220616_211638/72418756/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/72483781/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/72484094/ccs 3757 Y Y tandem full|left-partial 1 -m64011_220616_211638/72485284/ccs 558 Y Y scAAV right-partial 1 -m64011_220616_211638/72485708/ccs 2473 Y N ssAAV full 2 -m64011_220616_211638/72549075/ccs 2363 Y N ssAAV full 2 -m64011_220616_211638/72615821/ccs 2411 Y Y tandem full|right-partial 1 -m64011_220616_211638/72616328/ccs 4656 Y Y scAAV full 1 -m64011_220616_211638/72680350/ccs 2467 Y N ssAAV full 2 -m64011_220616_211638/72876864/ccs/rev 3632 Y Y scAAV left-partial 1 -m64011_220616_211638/73008028/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/73138619/ccs 3171 Y Y scAAV left-partial 1 -m64011_220616_211638/73138744/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/73269446/ccs 6021 Y Y scAAV full|left-partial 1 -m64011_220616_211638/73271220/ccs 4721 Y Y scAAV full 1 -m64011_220616_211638/73271289/ccs/rev 2454 Y N ssAAV full 1 -m64011_220616_211638/73337211/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/73337629/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/73402065/ccs/rev 4799 Y Y scAAV full 1 -m64011_220616_211638/73534102/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/73599379/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/73861010/ccs/fwd 2986 Y N ssAAV right-partial 1 -m64011_220616_211638/73861783/ccs 2468 Y N ssAAV full 2 -m64011_220616_211638/73926876/ccs 2697 Y Y scAAV full|left-partial 1 -m64011_220616_211638/74056390/ccs 1412 Y Y scAAV right-partial 1 -m64011_220616_211638/74056679/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/74123911/ccs 2487 Y Y scAAV full|right-partial 1 -m64011_220616_211638/74123993/ccs 4758 Y Y scAAV full 1 -m64011_220616_211638/74252774/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/74318914/ccs/fwd 4786 Y Y scAAV full 1 -m64011_220616_211638/74319113/ccs 1743 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/74449389/ccs 1435 Y N ssAAV right-partial 2 -m64011_220616_211638/74450099/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/74582400/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/74645526/ccs 2484 Y N ssAAV full 2 -m64011_220616_211638/74778140/ccs 2984 Y Y scAAV right-partial 1 -m64011_220616_211638/74843202/ccs/fwd 4773 Y Y scAAV full 1 -m64011_220616_211638/74844831/ccs 2727 Y N ssAAV left-partial 2 -m64011_220616_211638/74908271/ccs 2433 Y N ssAAV full 2 -m64011_220616_211638/75106444/ccs 2414 Y Y tandem full|right-partial 1 -m64011_220616_211638/75302094/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/75303319/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/75368910/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/75432055/ccs 4814 Y Y scAAV full 1 -m64011_220616_211638/75432081/ccs/fwd 4715 Y Y scAAV full 1 -m64011_220616_211638/75434782/ccs 4546 Y Y scAAV right-partial 1 -m64011_220616_211638/75498401/ccs 1854 Y N ssAAV left-partial 2 -m64011_220616_211638/75564028/ccs 1362 Y Y vector|repcap vector+backbone|NA 1 -m64011_220616_211638/75631078/ccs/rev 7911 Y Y vector|repcap backbone|NA 1 -m64011_220616_211638/75694482/ccs 1757 Y N ssAAV left-partial 2 -m64011_220616_211638/75761982/ccs/rev 2504 Y Y scAAV left-partial 1 -m64011_220616_211638/75827009/ccs 3347 Y Y scAAV right-partial 1 -m64011_220616_211638/75827282/ccs/rev 2096 Y N ssAAV right-partial 1 -m64011_220616_211638/75891503/ccs 4670 Y Y scAAV full 1 -m64011_220616_211638/75893553/ccs 2492 Y N ssAAV full 2 -m64011_220616_211638/75958891/ccs/rev 1052 Y N unclassified right-partial 1 -m64011_220616_211638/76087447/ccs 4769 Y Y scAAV full 1 -m64011_220616_211638/76153313/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/76153978/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/76219041/ccs 4671 Y Y scAAV full 1 -m64011_220616_211638/76219398/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/76220129/ccs 4710 Y Y scAAV full 1 -m64011_220616_211638/76221091/ccs/fwd 4797 Y Y scAAV full 1 -m64011_220616_211638/76284790/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/76349730/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/76416681/ccs 2126 Y N ssAAV full 2 -m64011_220616_211638/76417474/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/76480831/ccs/rev 4155 Y Y scAAV right-partial 1 -m64011_220616_211638/76547622/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/76547816/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/76612622/ccs/fwd 4761 Y Y scAAV full 1 -m64011_220616_211638/76614397/ccs 3577 Y Y scAAV right-partial 1 -m64011_220616_211638/76678856/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/76743663/ccs 3575 Y Y scAAV right-partial 1 -m64011_220616_211638/76744217/ccs/fwd 4926 Y Y scAAV full 1 -m64011_220616_211638/76744878/ccs/fwd 4690 Y Y scAAV full 1 -m64011_220616_211638/76745356/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/76809613/ccs 2264 Y N ssAAV full 2 -m64011_220616_211638/76810242/ccs/fwd 4747 Y Y scAAV full 1 -m64011_220616_211638/76810279/ccs 2373 Y N ssAAV full 2 -m64011_220616_211638/76810948/ccs 2709 Y Y tandem full|left-partial 1 -m64011_220616_211638/76874628/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/76875028/ccs 2325 Y N ssAAV full 2 -m64011_220616_211638/76875424/ccs 2434 Y N ssAAV full 2 -m64011_220616_211638/76875737/ccs 4813 Y Y scAAV full 1 -m64011_220616_211638/77005441/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/77136509/ccs/rev 4784 Y Y scAAV full 1 -m64011_220616_211638/77203776/ccs/rev 3543 Y N unclassified right-partial 1 -m64011_220616_211638/77267423/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/77267581/ccs 2514 Y N ssAAV full 2 -m64011_220616_211638/77333661/ccs 4316 Y Y scAAV right-partial 1 -m64011_220616_211638/77334271/ccs 2375 Y N ssAAV full 2 -m64011_220616_211638/77465562/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/77596062/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/77661343/ccs/rev 4679 Y Y scAAV full 1 -m64011_220616_211638/77662701/ccs 4703 Y Y scAAV full 1 -m64011_220616_211638/77726108/ccs/rev 2414 Y Y scAAV full|right-partial 1 -m64011_220616_211638/77792451/ccs 2979 Y Y tandem full|partial 1 -m64011_220616_211638/77923580/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/77989170/ccs 2355 Y N ssAAV full 2 -m64011_220616_211638/77989230/ccs/fwd 2556 Y Y scAAV full|backbone 1 -m64011_220616_211638/78120427/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/78121164/ccs 4765 Y Y scAAV full 1 -m64011_220616_211638/78185830/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/78186878/ccs/fwd 2320 Y N ssAAV left-partial 1 -m64011_220616_211638/78252073/ccs/fwd 4806 Y Y scAAV full 1 -m64011_220616_211638/78252368/ccs 2185 Y N ssAAV partial 2 -m64011_220616_211638/78315880/ccs/rev 2679 Y N unclassified left-partial 1 -m64011_220616_211638/78316310/ccs 3067 Y Y host NA 1 -m64011_220616_211638/78316973/ccs 2408 Y N ssAAV full 2 -m64011_220616_211638/78383611/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/78449075/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/78513253/ccs 3338 Y Y scAAV backbone 1 -m64011_220616_211638/78579365/ccs 4699 Y Y scAAV full 1 -m64011_220616_211638/78580124/ccs/rev 3812 Y Y tandem right-partial 1 -m64011_220616_211638/78645767/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/78710799/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/78775333/ccs 4771 Y Y scAAV full 1 -m64011_220616_211638/78776500/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/78840931/ccs/rev 3492 Y Y scAAV right-partial 1 -m64011_220616_211638/78841695/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/78907730/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/78908183/ccs 2604 Y N ssAAV left-partial 2 -m64011_220616_211638/78972633/ccs 2445 Y N ssAAV full 2 -m64011_220616_211638/78973312/ccs 2287 Y N ssAAV right-partial 2 -m64011_220616_211638/79038043/ccs/fwd 1681 Y Y scAAV right-partial 1 -m64011_220616_211638/79168517/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/79233311/ccs 3503 Y Y scAAV right-partial 1 -m64011_220616_211638/79235519/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/79300534/ccs 4776 Y Y scAAV full 1 -m64011_220616_211638/79364779/ccs/fwd 4778 Y Y scAAV full 1 -m64011_220616_211638/79495410/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/79561210/ccs 924 Y Y scAAV partial 1 -m64011_220616_211638/79562698/ccs 3704 Y N repcap NA 1 -m64011_220616_211638/79562731/ccs 1698 Y N ssAAV right-partial 2 -m64011_220616_211638/79628576/ccs/rev 1123 Y N unclassified right-partial 1 -m64011_220616_211638/79628776/ccs 1888 Y Y scAAV right-partial 1 -m64011_220616_211638/79692262/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/79759507/ccs/fwd 4780 Y Y scAAV full 1 -m64011_220616_211638/79759569/ccs/rev 4720 Y Y scAAV full 1 -m64011_220616_211638/79825045/ccs/fwd 4624 Y Y scAAV full 1 -m64011_220616_211638/79889853/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/79954484/ccs 2287 Y N ssAAV left-partial 2 -m64011_220616_211638/79954795/ccs/fwd 4806 Y Y scAAV full 1 -m64011_220616_211638/79954868/ccs 5081 Y Y scAAV full 1 -m64011_220616_211638/80020200/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/80021580/ccs/rev 2706 Y Y scAAV left-partial 1 -m64011_220616_211638/80021621/ccs/rev 4779 Y Y scAAV full 1 -m64011_220616_211638/80087405/ccs 2681 Y Y scAAV full|left-partial 1 -m64011_220616_211638/80087714/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/80150637/ccs 2465 Y N ssAAV full 2 -m64011_220616_211638/80153349/ccs 764 Y Y scAAV right-partial 1 -m64011_220616_211638/80217035/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/80282023/ccs 1213 Y N ssAAV partial 2 -m64011_220616_211638/80282521/ccs/rev 967 Y Y scAAV right-partial 1 -m64011_220616_211638/80283129/ccs/fwd 3003 Y Y scAAV left-partial 1 -m64011_220616_211638/80348814/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/80348911/ccs 2410 Y Y tandem full|right-partial 1 -m64011_220616_211638/80349509/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/80413969/ccs/fwd 4698 Y Y scAAV full 1 -m64011_220616_211638/80479001/ccs/rev 4184 Y Y scAAV right-partial 1 -m64011_220616_211638/80480189/ccs/rev 3575 Y Y scAAV right-partial 1 -m64011_220616_211638/80609593/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/80611206/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/80872154/ccs/rev 2191 Y Y scAAV right-partial 1 -m64011_220616_211638/81004420/ccs 3704 Y Y scAAV right-partial 1 -m64011_220616_211638/81069420/ccs 1415 Y Y scAAV left-partial 1 -m64011_220616_211638/81070299/ccs/rev 2440 Y N ssAAV full 1 -m64011_220616_211638/81134194/ccs 4835 Y Y scAAV full 1 -m64011_220616_211638/81200356/ccs/rev 1981 Y N ssAAV left-partial 1 -m64011_220616_211638/81266983/ccs/fwd 5804 Y N host NA 1 -m64011_220616_211638/81330979/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/81397567/ccs 1904 Y Y scAAV right-partial 1 -m64011_220616_211638/81398222/ccs 1819 Y N ssAAV left-partial 2 -m64011_220616_211638/81528430/ccs 2492 Y N ssAAV full 2 -m64011_220616_211638/81529300/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/81593807/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/81593986/ccs/fwd 3203 Y Y scAAV left-partial 1 -m64011_220616_211638/81594758/ccs 3678 Y Y scAAV right-partial 1 -m64011_220616_211638/81659922/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/81790213/ccs 2417 Y N ssAAV full 2 -m64011_220616_211638/81856392/ccs 1069 Y N ssAAV left-partial 2 -m64011_220616_211638/82183384/ccs 4791 Y Y scAAV full 1 -m64011_220616_211638/82249218/ccs/fwd 2203 Y N ssAAV right-partial 1 -m64011_220616_211638/82250486/ccs 1718 Y N ssAAV right-partial 2 -m64011_220616_211638/82313770/ccs 2344 Y N ssAAV full 2 -m64011_220616_211638/82315183/ccs 1852 Y Y scAAV right-partial 1 -m64011_220616_211638/82379530/ccs/rev 2453 Y N ssAAV full 1 -m64011_220616_211638/82444594/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/82511755/ccs/rev 3445 Y Y scAAV right-partial 1 -m64011_220616_211638/82708493/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/82708597/ccs 2259 Y N ssAAV full 2 -m64011_220616_211638/82905559/ccs 4787 Y Y tandem full 1 -m64011_220616_211638/82970104/ccs 2432 Y N ssAAV full 2 -m64011_220616_211638/83034198/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/83035357/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/83036137/ccs 4776 Y Y scAAV full 1 -m64011_220616_211638/83166236/ccs/fwd 2452 Y N ssAAV full 1 -m64011_220616_211638/83166979/ccs/rev 1704 Y N ssAAV right-partial 1 -m64011_220616_211638/83233151/ccs/fwd 2452 Y N ssAAV full 1 -m64011_220616_211638/83299070/ccs 2398 Y Y tandem full|right-partial 1 -m64011_220616_211638/83362291/ccs 1002 Y N ssAAV right-partial 2 -m64011_220616_211638/83364476/ccs/fwd 3187 Y Y scAAV right-partial 1 -m64011_220616_211638/83427785/ccs/rev 4782 Y Y scAAV full 1 -m64011_220616_211638/83493282/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/83559314/ccs 2426 Y N ssAAV full 2 -m64011_220616_211638/83625161/ccs/fwd 2455 Y N ssAAV full 1 -m64011_220616_211638/83691315/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/83691461/ccs 1983 Y N ssAAV right-partial 2 -m64011_220616_211638/83755894/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/83756903/ccs/rev 4786 Y Y scAAV full 1 -m64011_220616_211638/83821736/ccs 3309 Y N unclassified backbone 1 -m64011_220616_211638/83888596/ccs/rev 2001 Y Y scAAV right-partial 1 -m64011_220616_211638/83954309/ccs 4496 Y Y scAAV left-partial 1 -m64011_220616_211638/84084871/ccs/fwd 2850 Y Y scAAV vector+backbone 1 -m64011_220616_211638/84150088/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/84214805/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/84215440/ccs/fwd 6647 Y Y repcap NA 1 -m64011_220616_211638/84215660/ccs 2374 Y Y repcap NA 1 -m64011_220616_211638/84216326/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/84216605/ccs 2555 Y N ssAAV full 2 -m64011_220616_211638/84346426/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/84412331/ccs/fwd 4780 Y Y scAAV full 1 -m64011_220616_211638/84477397/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/84541965/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/84675029/ccs/rev 3895 Y Y scAAV left-partial 1 -m64011_220616_211638/84675055/ccs/rev 951 Y Y scAAV left-partial 1 -m64011_220616_211638/84805719/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/84806041/ccs 3531 Y Y scAAV left-partial 1 -m64011_220616_211638/84936316/ccs 2887 Y N unclassified left-partial 1 -m64011_220616_211638/84936967/ccs/fwd 3832 N N NA NA 1 -m64011_220616_211638/84937113/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/85000575/ccs 4703 Y Y scAAV full 1 -m64011_220616_211638/85068063/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/85133845/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/85394407/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/85394711/ccs 2432 Y N ssAAV full 2 -m64011_220616_211638/85396082/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/85526100/ccs/fwd 2294 Y N ssAAV full 1 -m64011_220616_211638/85526812/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/85527307/ccs/fwd 2449 Y N ssAAV full 1 -m64011_220616_211638/85592603/ccs 2361 Y Y scAAV full|right-partial 1 -m64011_220616_211638/85657264/ccs 2426 Y N ssAAV full 2 -m64011_220616_211638/85658385/ccs 1850 Y Y scAAV right-partial 1 -m64011_220616_211638/85722492/ccs 3479 Y Y scAAV right-partial 1 -m64011_220616_211638/85788600/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/85788844/ccs/fwd 4757 Y Y scAAV full 1 -m64011_220616_211638/85789052/ccs 2379 Y Y tandem full|right-partial 1 -m64011_220616_211638/85918036/ccs 2440 Y N ssAAV full 2 -m64011_220616_211638/85984117/ccs 4787 Y Y scAAV full 1 -m64011_220616_211638/85984658/ccs/fwd 4703 Y Y scAAV full 1 -m64011_220616_211638/86181656/ccs/fwd 2453 Y N ssAAV full 1 -m64011_220616_211638/86182382/ccs 4281 Y Y scAAV left-partial 1 -m64011_220616_211638/86246587/ccs/fwd 2217 Y N ssAAV right-partial 1 -m64011_220616_211638/86247033/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/86313816/ccs/rev 4757 Y Y scAAV full 1 -m64011_220616_211638/86442689/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/86574265/ccs 4772 Y Y scAAV full 1 -m64011_220616_211638/86575445/ccs 4812 Y Y scAAV full 1 -m64011_220616_211638/86638776/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/86705024/ccs/rev 4811 Y Y scAAV full 1 -m64011_220616_211638/86705212/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/86705710/ccs 998 Y Y scAAV left-partial 1 -m64011_220616_211638/86705736/ccs/rev 711 Y Y scAAV left-partial 1 -m64011_220616_211638/86705869/ccs 2419 Y Y scAAV full|right-partial 1 -m64011_220616_211638/86771776/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/86835574/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/86967896/ccs/fwd 4778 Y Y scAAV full 1 -m64011_220616_211638/87031816/ccs/rev 3508 Y Y scAAV right-partial 1 -m64011_220616_211638/87098233/ccs 1447 Y Y scAAV right-partial 1 -m64011_220616_211638/87099154/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/87099668/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/87164205/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/87165031/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/87294501/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/87294606/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/87359543/ccs 561 Y Y scAAV right-partial 1 -m64011_220616_211638/87360592/ccs/rev 2316 Y N ssAAV left-partial 1 -m64011_220616_211638/87425693/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/87426973/ccs/fwd 4498 Y Y scAAV right-partial 1 -m64011_220616_211638/87492130/ccs/fwd 1814 Y Y scAAV right-partial 1 -m64011_220616_211638/87623539/ccs 2326 Y N ssAAV full 2 -m64011_220616_211638/87623639/ccs 4794 Y Y scAAV full 1 -m64011_220616_211638/87688794/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/87690030/ccs/rev 4688 Y Y scAAV full 1 -m64011_220616_211638/87753673/ccs 4896 Y Y scAAV full 1 -m64011_220616_211638/87754118/ccs 1562 Y N ssAAV left-partial 2 -m64011_220616_211638/87754165/ccs 1581 Y Y scAAV left-partial 1 -m64011_220616_211638/87754311/ccs 2412 Y Y scAAV full|right-partial 1 -m64011_220616_211638/87884052/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/87886076/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/87949808/ccs/fwd 1690 Y N ssAAV left-partial 1 -m64011_220616_211638/87951789/ccs/rev 4688 Y Y scAAV full 1 -m64011_220616_211638/88017138/ccs 2619 Y N ssAAV right-partial 2 -m64011_220616_211638/88147304/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/88213483/ccs 2480 Y N ssAAV full 2 -m64011_220616_211638/88277320/ccs 2471 Y N ssAAV full 2 -m64011_220616_211638/88277697/ccs 2370 Y N ssAAV full 2 -m64011_220616_211638/88279548/ccs 4689 Y Y scAAV full 1 -m64011_220616_211638/88343415/ccs/fwd 2742 Y Y vector|repcap vector+backbone|NA 1 -m64011_220616_211638/88344937/ccs 2055 Y Y scAAV vector+backbone 1 -m64011_220616_211638/88539305/ccs 3229 Y Y scAAV right-partial 1 -m64011_220616_211638/88541189/ccs/fwd 4701 Y Y scAAV full 1 -m64011_220616_211638/88542020/ccs 4353 Y Y scAAV left-partial 1 -m64011_220616_211638/88605030/ccs 2102 Y Y tandem right-partial 1 -m64011_220616_211638/88605817/ccs 3275 Y Y scAAV right-partial 1 -m64011_220616_211638/88606922/ccs 2378 Y Y scAAV full|right-partial 1 -m64011_220616_211638/88670607/ccs 4770 Y Y scAAV full 1 -m64011_220616_211638/88736414/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/88804033/ccs 4761 Y Y scAAV full 1 -m64011_220616_211638/88867765/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/88868658/ccs 5722 Y Y scAAV full 1 -m64011_220616_211638/88869087/ccs 2370 Y N ssAAV full 2 -m64011_220616_211638/88934138/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/88998631/ccs/fwd 1803 Y Y scAAV left-partial 1 -m64011_220616_211638/89000270/ccs 2437 Y N ssAAV full 2 -m64011_220616_211638/89063950/ccs 4776 Y Y scAAV full 1 -m64011_220616_211638/89064136/ccs 530 Y Y scAAV right-partial 1 -m64011_220616_211638/89130242/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/89196382/ccs 2984 Y Y scAAV right-partial 1 -m64011_220616_211638/89328140/ccs 2428 Y N ssAAV full 2 -m64011_220616_211638/89458752/ccs 2402 Y Y tandem full|right-partial 1 -m64011_220616_211638/89524125/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/89524535/ccs 2622 Y N ssAAV full 2 -m64011_220616_211638/89524572/ccs 5737 Y Y repcap NA 1 -m64011_220616_211638/89588710/ccs 2421 Y N ssAAV full 2 -m64011_220616_211638/89655846/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/89718819/ccs 2411 Y N ssAAV full 2 -m64011_220616_211638/89785791/ccs 2470 Y N ssAAV full 2 -m64011_220616_211638/89850030/ccs 996 Y N ssAAV right-partial 2 -m64011_220616_211638/89852377/ccs 4727 Y Y scAAV full 1 -m64011_220616_211638/89916121/ccs 4928 Y Y scAAV full 1 -m64011_220616_211638/89981257/ccs 4804 Y Y scAAV full 1 -m64011_220616_211638/89982492/ccs/fwd 4462 Y Y scAAV full|right-partial 1 -m64011_220616_211638/89982831/ccs 2339 Y N ssAAV full 2 -m64011_220616_211638/89983443/ccs 928 Y N ssAAV right-partial 2 -m64011_220616_211638/90046504/ccs 1536 Y N ssAAV right-partial 2 -m64011_220616_211638/90048515/ccs 2466 Y N ssAAV full 2 -m64011_220616_211638/90180295/ccs 975 Y Y scAAV partial 1 -m64011_220616_211638/90244304/ccs/fwd 1800 Y Y scAAV right-partial 1 -m64011_220616_211638/90244421/ccs 2616 Y N ssAAV right-partial 2 -m64011_220616_211638/90374932/ccs 3214 Y Y scAAV partial 1 -m64011_220616_211638/90376982/ccs/rev 4784 Y Y scAAV full 1 -m64011_220616_211638/90505941/ccs 853 Y N unclassified right-partial 1 -m64011_220616_211638/90572252/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/90572297/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/90573121/ccs/rev 2224 Y N ssAAV right-partial 1 -m64011_220616_211638/90637828/ccs/fwd 2468 Y N ssAAV full 1 -m64011_220616_211638/90702103/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/90704065/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/90767999/ccs/fwd 4906 Y Y scAAV full 1 -m64011_220616_211638/90769038/ccs 2907 Y Y scAAV right-partial 1 -m64011_220616_211638/90769465/ccs 1024 Y N ssAAV right-partial 2 -m64011_220616_211638/90770220/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/90832955/ccs 1989 Y N ssAAV left-partial 2 -m64011_220616_211638/90834799/ccs/rev 4802 Y Y scAAV full 1 -m64011_220616_211638/90900397/ccs 4792 Y Y scAAV full 1 -m64011_220616_211638/90964491/ccs/fwd 6191 Y Y scAAV vector+backbone 1 -m64011_220616_211638/91030096/ccs/rev 3015 Y Y scAAV right-partial 1 -m64011_220616_211638/91096424/ccs 4800 Y Y scAAV full 1 -m64011_220616_211638/91097289/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/91097657/ccs/fwd 840 Y Y scAAV right-partial 1 -m64011_220616_211638/91161230/ccs 2650 Y Y scAAV right-partial|partial 1 -m64011_220616_211638/91162276/ccs 4704 Y Y scAAV full 1 -m64011_220616_211638/91163382/ccs/rev 2407 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/91227016/ccs/fwd 2247 Y N ssAAV left-partial 1 -m64011_220616_211638/91294038/ccs 1274 Y N ssAAV right-partial 2 -m64011_220616_211638/91358094/ccs/fwd 4724 Y Y scAAV full 1 -m64011_220616_211638/91358636/ccs 2920 Y Y scAAV left-partial 1 -m64011_220616_211638/91359660/ccs 4768 Y Y scAAV full 1 -m64011_220616_211638/91423771/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/91424252/ccs 3385 Y Y scAAV left-partial 1 -m64011_220616_211638/91490803/ccs 2813 Y Y tandem vector+backbone|left-partial 1 -m64011_220616_211638/91556510/ccs 1415 Y N ssAAV right-partial 2 -m64011_220616_211638/91556525/ccs 1275 Y Y scAAV right-partial 1 -m64011_220616_211638/91621617/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/91687674/ccs/rev 3077 Y Y scAAV backbone 1 -m64011_220616_211638/91750587/ccs 4889 Y Y scAAV full 1 -m64011_220616_211638/91752782/ccs 2372 Y Y scAAV full|right-partial 1 -m64011_220616_211638/91883012/ccs 2395 Y Y scAAV full|right-partial 1 -m64011_220616_211638/91884053/ccs/fwd 1294 Y Y scAAV right-partial 1 -m64011_220616_211638/91947308/ccs/fwd 3486 Y Y scAAV right-partial 1 -m64011_220616_211638/91947651/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/91948006/ccs 3156 Y Y scAAV partial 1 -m64011_220616_211638/92013083/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/92013294/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/92013830/ccs 1839 Y N ssAAV right-partial 2 -m64011_220616_211638/92014659/ccs 4804 Y Y scAAV full 1 -m64011_220616_211638/92146246/ccs 2543 Y N ssAAV full 2 -m64011_220616_211638/92210261/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/92211352/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/92275495/ccs 1967 Y N ssAAV right-partial 2 -m64011_220616_211638/92276141/ccs 4411 Y Y scAAV left-partial 1 -m64011_220616_211638/92276303/ccs 2529 Y N ssAAV right-partial 2 -m64011_220616_211638/92276552/ccs/rev 4694 Y Y scAAV full 1 -m64011_220616_211638/92340300/ccs 2445 Y N ssAAV full 2 -m64011_220616_211638/92341882/ccs 3592 Y Y scAAV right-partial 1 -m64011_220616_211638/92342519/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/92407528/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/92471392/ccs 2530 Y N ssAAV left-partial 2 -m64011_220616_211638/92537431/ccs 1848 Y N ssAAV right-partial 2 -m64011_220616_211638/92537543/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/92603351/ccs/rev 4776 Y Y scAAV full 1 -m64011_220616_211638/92667967/ccs/fwd 7763 Y Y scAAV full|right-partial 1 -m64011_220616_211638/92668383/ccs/fwd 1002 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/92736159/ccs/rev 2411 Y Y tandem full|right-partial 1 -m64011_220616_211638/92865474/ccs 1300 Y Y scAAV partial 1 -m64011_220616_211638/92931182/ccs 4719 Y Y scAAV full 1 -m64011_220616_211638/92931605/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/92932339/ccs 4788 Y Y scAAV full 1 -m64011_220616_211638/92996286/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/92998217/ccs 2408 Y N ssAAV full 2 -m64011_220616_211638/93061427/ccs 2463 Y N ssAAV full 2 -m64011_220616_211638/93063286/ccs/rev 4781 Y Y scAAV full 1 -m64011_220616_211638/93127630/ccs/fwd 4776 Y Y scAAV full 1 -m64011_220616_211638/93127822/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/93129037/ccs 3104 Y Y scAAV right-partial 1 -m64011_220616_211638/93193598/ccs 1074 Y Y scAAV partial 1 -m64011_220616_211638/93258043/ccs 436 Y Y scAAV right-partial 1 -m64011_220616_211638/93258230/ccs 4751 Y Y scAAV full 1 -m64011_220616_211638/93324230/ccs 7119 Y Y scAAV full 1 -m64011_220616_211638/93388940/ccs 2413 Y N ssAAV full 2 -m64011_220616_211638/93388974/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/93389959/ccs 3615 Y Y repcap NA 1 -m64011_220616_211638/93391200/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/93456377/ccs/rev 4710 Y Y scAAV full 1 -m64011_220616_211638/93522568/ccs 2750 Y Y scAAV full|right-partial 1 -m64011_220616_211638/93587087/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/93587856/ccs/fwd 4242 Y Y scAAV full|right-partial 1 -m64011_220616_211638/93716608/ccs 4765 Y Y scAAV full 1 -m64011_220616_211638/93717788/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/93718505/ccs 2593 Y Y scAAV full|left-partial 1 -m64011_220616_211638/93718834/ccs 2404 Y Y tandem full|right-partial 1 -m64011_220616_211638/93783574/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/93848505/ccs 2477 Y N ssAAV full 2 -m64011_220616_211638/93850206/ccs 2397 Y N ssAAV full 2 -m64011_220616_211638/93978984/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/93979694/ccs 2621 Y N ssAAV right-partial 2 -m64011_220616_211638/94044640/ccs 504 Y Y tandem right-partial 1 -m64011_220616_211638/94175761/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/94176128/ccs 2465 Y N ssAAV full 2 -m64011_220616_211638/94177635/ccs/fwd 797 Y Y scAAV right-partial 1 -m64011_220616_211638/94242307/ccs 2390 Y Y scAAV full|right-partial 1 -m64011_220616_211638/94243531/ccs 7251 Y N unclassified full 1 -m64011_220616_211638/94306455/ccs 2489 Y N ssAAV full 2 -m64011_220616_211638/94306551/ccs/rev 1740 Y N host NA 1 -m64011_220616_211638/94308925/ccs 2910 Y Y scAAV right-partial 1 -m64011_220616_211638/94438747/ccs/fwd 4688 Y Y scAAV full 1 -m64011_220616_211638/94503077/ccs/fwd 1935 Y N ssAAV left-partial 1 -m64011_220616_211638/94505332/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/94568503/ccs 2519 Y N ssAAV full 2 -m64011_220616_211638/94569803/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/94636681/ccs 7767 Y Y repcap NA 1 -m64011_220616_211638/94765999/ccs 2775 N N NA NA 1 -m64011_220616_211638/94898420/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/94962212/ccs 2439 Y N ssAAV full 2 -m64011_220616_211638/94964289/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/94964322/ccs/fwd 2141 Y Y scAAV right-partial 1 -m64011_220616_211638/95092929/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/95159508/ccs/rev 4787 Y Y scAAV full 1 -m64011_220616_211638/95224978/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/95225285/ccs 3993 Y Y scAAV right-partial 1 -m64011_220616_211638/95290627/ccs 3437 Y Y scAAV right-partial 1 -m64011_220616_211638/95291912/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/95357746/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/95420577/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/95420923/ccs 2337 Y N ssAAV full 2 -m64011_220616_211638/95486869/ccs/fwd 3355 Y Y scAAV left-partial 1 -m64011_220616_211638/95619253/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/95749018/ccs 4717 Y Y scAAV full 1 -m64011_220616_211638/95814457/ccs 2501 Y Y scAAV full|right-partial 1 -m64011_220616_211638/95816105/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/95880912/ccs/rev 4779 Y Y scAAV full 1 -m64011_220616_211638/95945438/ccs 4802 Y Y scAAV full 1 -m64011_220616_211638/96077522/ccs 3573 Y Y scAAV right-partial 1 -m64011_220616_211638/96078289/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/96141945/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/96142471/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/96143146/ccs 1261 Y Y scAAV right-partial 1 -m64011_220616_211638/96207649/ccs/fwd 2691 Y Y scAAV full|right-partial 1 -m64011_220616_211638/96273207/ccs 2401 Y N ssAAV full 2 -m64011_220616_211638/96274553/ccs/fwd 3347 Y Y scAAV partial 1 -m64011_220616_211638/96404859/ccs 4699 Y Y scAAV full 1 -m64011_220616_211638/96534582/ccs/rev 4772 Y Y scAAV full 1 -m64011_220616_211638/96536986/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/96600450/ccs 2472 Y N ssAAV full 2 -m64011_220616_211638/96668246/ccs 4689 Y Y scAAV full 1 -m64011_220616_211638/96731259/ccs/fwd 3512 Y Y scAAV right-partial 1 -m64011_220616_211638/96731297/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/96732525/ccs/rev 4506 Y Y scAAV right-partial 1 -m64011_220616_211638/96797980/ccs 8953 Y Y helper NA 1 -m64011_220616_211638/96863722/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/96928050/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/96995499/ccs 2945 Y Y scAAV right-partial 1 -m64011_220616_211638/97061299/ccs 2540 Y N ssAAV full 2 -m64011_220616_211638/97125674/ccs 4771 Y Y scAAV full 1 -m64011_220616_211638/97256653/ccs/rev 4754 Y Y scAAV full 1 -m64011_220616_211638/97322750/ccs 4674 Y Y scAAV full 1 -m64011_220616_211638/97323110/ccs 4114 Y Y scAAV left-partial 1 -m64011_220616_211638/97323737/ccs 2359 Y N ssAAV full 2 -m64011_220616_211638/97389013/ccs/fwd 3894 Y Y scAAV right-partial 1 -m64011_220616_211638/97649105/ccs 1721 Y Y scAAV left-partial 1 -m64011_220616_211638/97714810/ccs 2424 Y N ssAAV full 2 -m64011_220616_211638/97781713/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/97846297/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/97911622/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/97912503/ccs/fwd 4797 Y Y scAAV full 1 -m64011_220616_211638/97976450/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/97978379/ccs 2569 Y Y scAAV full|right-partial 1 -m64011_220616_211638/97979054/ccs 1737 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/97979157/ccs/rev 2425 Y Y tandem full|right-partial 1 -m64011_220616_211638/98041903/ccs 3185 Y Y scAAV right-partial 1 -m64011_220616_211638/98042509/ccs/rev 1812 Y Y scAAV left-partial 1 -m64011_220616_211638/98043499/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/98043619/ccs/rev 1750 Y Y repcap NA 1 -m64011_220616_211638/98109722/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/98109815/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/98173410/ccs 2388 Y N ssAAV full 2 -m64011_220616_211638/98174407/ccs 3125 Y Y scAAV left-partial 1 -m64011_220616_211638/98174817/ccs/rev 4820 Y Y scAAV full 1 -m64011_220616_211638/98238605/ccs/fwd 4789 Y Y scAAV full 1 -m64011_220616_211638/98240888/ccs/rev 4684 Y Y scAAV full 1 -m64011_220616_211638/98240986/ccs 4683 Y Y scAAV full 1 -m64011_220616_211638/98370811/ccs/fwd 4778 Y Y scAAV full 1 -m64011_220616_211638/98437108/ccs/fwd 5503 Y Y scAAV right-partial 1 -m64011_220616_211638/98437746/ccs 2351 Y N ssAAV right-partial 2 -m64011_220616_211638/98501972/ccs 4692 Y Y scAAV full 1 -m64011_220616_211638/98566468/ccs 2467 Y N ssAAV full 2 -m64011_220616_211638/98567385/ccs 3867 Y Y scAAV full 1 -m64011_220616_211638/98632068/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/98632385/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/98632976/ccs 2390 Y N ssAAV full 2 -m64011_220616_211638/98699610/ccs/fwd 2454 Y N ssAAV full 1 -m64011_220616_211638/98764937/ccs 5000 Y Y scAAV full 1 -m64011_220616_211638/98960307/ccs 5852 N N NA NA 1 -m64011_220616_211638/99026012/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/99091128/ccs/rev 4711 Y Y scAAV full 1 -m64011_220616_211638/99092670/ccs 2784 Y N ssAAV right-partial 2 -m64011_220616_211638/99156816/ccs 1537 Y N ssAAV right-partial 2 -m64011_220616_211638/99158727/ccs 2368 Y Y scAAV full|right-partial 1 -m64011_220616_211638/99288062/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/99353527/ccs/rev 4777 Y Y scAAV full 1 -m64011_220616_211638/99418149/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/99420437/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/99420656/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/99484819/ccs/fwd 4308 Y Y scAAV left-partial 1 -m64011_220616_211638/99551208/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/99615793/ccs/rev 3434 Y Y scAAV right-partial 1 -m64011_220616_211638/99616344/ccs/rev 4377 Y Y scAAV backbone 1 -m64011_220616_211638/99616796/ccs 4775 Y Y scAAV full 1 -m64011_220616_211638/99748462/ccs 1730 Y Y scAAV right-partial 1 -m64011_220616_211638/99812871/ccs 3211 Y Y scAAV right-partial 1 -m64011_220616_211638/99877867/ccs 4662 Y Y scAAV full 1 -m64011_220616_211638/99878769/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/99944271/ccs 4746 Y Y scAAV full 1 -m64011_220616_211638/100009931/ccs/fwd 4661 Y Y scAAV full 1 -m64011_220616_211638/100074238/ccs 4768 Y Y scAAV full 1 -m64011_220616_211638/100270732/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/100271648/ccs 2444 Y N ssAAV full 2 -m64011_220616_211638/100338024/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/100402317/ccs 2176 Y N ssAAV right-partial 2 -m64011_220616_211638/100403172/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/100403680/ccs/rev 2569 Y N ssAAV right-partial 1 -m64011_220616_211638/100467335/ccs 2159 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/100469242/ccs/fwd 4769 Y Y scAAV full 1 -m64011_220616_211638/100532954/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/100795517/ccs 2687 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/100796554/ccs 1159 Y N ssAAV right-partial 2 -m64011_220616_211638/100861326/ccs 2410 Y N ssAAV full 2 -m64011_220616_211638/100862408/ccs 2243 Y Y scAAV full|right-partial 1 -m64011_220616_211638/100927346/ccs/rev 4497 Y Y scAAV left-partial 1 -m64011_220616_211638/100927755/ccs 1238 Y Y scAAV right-partial 1 -m64011_220616_211638/100991779/ccs/fwd 977 Y N ssAAV right-partial 1 -m64011_220616_211638/100993139/ccs/rev 4768 Y Y scAAV full 1 -m64011_220616_211638/101058143/ccs 5141 Y Y scAAV full 1 -m64011_220616_211638/101059239/ccs 4705 Y Y scAAV full 1 -m64011_220616_211638/101124141/ccs 2464 Y N ssAAV full 2 -m64011_220616_211638/101189169/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/101255741/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/101320537/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/101320924/ccs 2410 Y N ssAAV full 2 -m64011_220616_211638/101321027/ccs/fwd 4764 Y Y scAAV full 1 -m64011_220616_211638/101386485/ccs 2389 Y N ssAAV full 2 -m64011_220616_211638/101515874/ccs 4796 Y Y scAAV full 1 -m64011_220616_211638/101582688/ccs 2718 Y N unclassified right-partial 1 -m64011_220616_211638/101583304/ccs 1516 Y N ssAAV right-partial 2 -m64011_220616_211638/101646837/ccs 2188 Y N ssAAV right-partial 2 -m64011_220616_211638/101647225/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/101712878/ccs/fwd 4698 Y Y scAAV full 1 -m64011_220616_211638/102040176/ccs 2429 Y N ssAAV full 2 -m64011_220616_211638/102040430/ccs/fwd 2407 Y N ssAAV full 1 -m64011_220616_211638/102041621/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/102106499/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/102171855/ccs/rev 2338 Y Y scAAV partial 1 -m64011_220616_211638/102172257/ccs 2289 Y N ssAAV right-partial 2 -m64011_220616_211638/102172276/ccs 4382 Y Y scAAV right-partial 1 -m64011_220616_211638/102236787/ccs/fwd 4777 Y Y scAAV full 1 -m64011_220616_211638/102238316/ccs 1873 Y Y scAAV right-partial 1 -m64011_220616_211638/102367926/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/102564197/ccs/rev 2373 Y N ssAAV full 1 -m64011_220616_211638/102565898/ccs 2434 Y N ssAAV full 2 -m64011_220616_211638/102632197/ccs 855 Y Y helper|vector NA|right-partial 1 -m64011_220616_211638/102761068/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/102959451/ccs 1894 Y Y scAAV right-partial 1 -m64011_220616_211638/102959808/ccs 1203 Y N ssAAV left-partial 2 -m64011_220616_211638/103088919/ccs 1240 Y Y scAAV right-partial 1 -m64011_220616_211638/103090401/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/103090635/ccs 4387 Y Y scAAV full 1 -m64011_220616_211638/103155542/ccs 2398 Y N ssAAV full 2 -m64011_220616_211638/103219616/ccs 4751 Y Y scAAV full 1 -m64011_220616_211638/103221328/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/103286408/ccs 6023 Y Y repcap NA 1 -m64011_220616_211638/103287470/ccs/rev 4803 Y Y scAAV full 1 -m64011_220616_211638/103350398/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/103350989/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/103352900/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/103417510/ccs/fwd 4779 Y Y scAAV full 1 -m64011_220616_211638/103417965/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/103418409/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/103481525/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/103483139/ccs 1841 Y Y scAAV right-partial 1 -m64011_220616_211638/103549037/ccs 4767 Y Y scAAV full 1 -m64011_220616_211638/103680191/ccs/fwd 4699 Y Y scAAV full 1 -m64011_220616_211638/103744669/ccs 2275 Y Y scAAV left-partial 1 -m64011_220616_211638/103745243/ccs 4693 Y Y scAAV full 1 -m64011_220616_211638/103811731/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/103874895/ccs/rev 4295 Y Y scAAV left-partial 1 -m64011_220616_211638/103875711/ccs 2324 Y N ssAAV left-partial 2 -m64011_220616_211638/103876355/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/104007107/ccs/rev 1913 Y Y scAAV left-partial 1 -m64011_220616_211638/104074016/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/104137427/ccs 3098 Y Y scAAV full|left-partial 1 -m64011_220616_211638/104139505/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/104269523/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/104334098/ccs/rev 4697 Y Y scAAV full 1 -m64011_220616_211638/104335066/ccs/fwd 4194 Y Y scAAV right-partial 1 -m64011_220616_211638/104398973/ccs 1152 Y Y scAAV right-partial 1 -m64011_220616_211638/104399817/ccs 3064 Y Y scAAV partial 1 -m64011_220616_211638/104465625/ccs 4740 Y Y scAAV full 1 -m64011_220616_211638/104532701/ccs/fwd 4759 Y Y scAAV full 1 -m64011_220616_211638/104596717/ccs 4770 Y Y scAAV full 1 -m64011_220616_211638/104597996/ccs 2367 Y N ssAAV full 2 -m64011_220616_211638/104728953/ccs 2516 Y N ssAAV full 2 -m64011_220616_211638/104793717/ccs/rev 2452 Y N ssAAV full 1 -m64011_220616_211638/104794581/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/104858036/ccs 2411 Y N ssAAV full 2 -m64011_220616_211638/104923714/ccs 4758 Y Y scAAV full 1 -m64011_220616_211638/104989916/ccs 515 Y N ssAAV right-partial 2 -m64011_220616_211638/104991275/ccs 4763 Y Y scAAV full 1 -m64011_220616_211638/105120905/ccs 7664 Y Y repcap NA 1 -m64011_220616_211638/105120926/ccs 2253 Y Y scAAV left-partial 1 -m64011_220616_211638/105185666/ccs 4736 Y Y scAAV full 1 -m64011_220616_211638/105318965/ccs/rev 4918 Y Y scAAV full 1 -m64011_220616_211638/105381932/ccs/fwd 1649 Y Y scAAV right-partial 1 -m64011_220616_211638/105382913/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/105448818/ccs 1325 Y N ssAAV partial 2 -m64011_220616_211638/105448876/ccs 2472 Y N ssAAV full 2 -m64011_220616_211638/105515281/ccs 2512 Y Y scAAV full|right-partial 1 -m64011_220616_211638/105579259/ccs/fwd 4602 Y Y scAAV full 1 -m64011_220616_211638/105644558/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/105645543/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/105711352/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/105776713/ccs/rev 4154 Y Y scAAV left-partial 1 -m64011_220616_211638/105842838/ccs 2516 Y N ssAAV full 2 -m64011_220616_211638/105973136/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/105973678/ccs/fwd 2594 Y N ssAAV left-partial 1 -m64011_220616_211638/106037669/ccs 2421 Y N ssAAV full 2 -m64011_220616_211638/106038814/ccs 2430 Y N ssAAV full 2 -m64011_220616_211638/106104477/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/106170702/ccs 2409 Y Y scAAV full|right-partial 1 -m64011_220616_211638/106234427/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/106235174/ccs/fwd 2422 Y N ssAAV full 1 -m64011_220616_211638/106497979/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/106563933/ccs 4829 Y Y scAAV full 1 -m64011_220616_211638/106629698/ccs 4788 Y Y scAAV full 1 -m64011_220616_211638/106694194/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/106694755/ccs 4701 Y Y scAAV full 1 -m64011_220616_211638/106758437/ccs 2369 Y Y scAAV left-partial 1 -m64011_220616_211638/106758840/ccs 4776 Y Y scAAV full 1 -m64011_220616_211638/106759282/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/106760514/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/106889859/ccs 2463 Y N ssAAV full 2 -m64011_220616_211638/107087779/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/107087790/ccs 1857 Y Y scAAV right-partial 1 -m64011_220616_211638/107088044/ccs 2366 Y N ssAAV full 2 -m64011_220616_211638/107151520/ccs 4730 Y Y scAAV full 1 -m64011_220616_211638/107218144/ccs 1766 Y N ssAAV right-partial 2 -m64011_220616_211638/107218804/ccs 4696 Y Y scAAV full 1 -m64011_220616_211638/107282954/ccs 2515 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/107348833/ccs 2419 Y Y scAAV left-partial 1 -m64011_220616_211638/107480673/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/107545273/ccs 2418 Y N ssAAV full 2 -m64011_220616_211638/107610454/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/107610481/ccs 2446 Y N ssAAV full 2 -m64011_220616_211638/107612130/ccs 1475 Y Y scAAV right-partial 1 -m64011_220616_211638/107612462/ccs/fwd 2454 Y N ssAAV full 1 -m64011_220616_211638/107676006/ccs/fwd 4801 Y Y scAAV full 1 -m64011_220616_211638/107676116/ccs/rev 4726 Y Y scAAV full 1 -m64011_220616_211638/107676400/ccs/rev 4789 Y Y scAAV full 1 -m64011_220616_211638/107677150/ccs 2889 Y N ssAAV right-partial 2 -m64011_220616_211638/107678431/ccs/rev 1336 Y Y scAAV right-partial 1 -m64011_220616_211638/107741753/ccs 1219 Y Y scAAV right-partial 1 -m64011_220616_211638/107741863/ccs/fwd 2447 Y N ssAAV full 1 -m64011_220616_211638/107743588/ccs 1903 Y Y scAAV left-partial 1 -m64011_220616_211638/107744079/ccs 353 Y Y scAAV left-partial|right-partial 1 -m64011_220616_211638/107809151/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/107809362/ccs 4699 Y Y scAAV full 1 -m64011_220616_211638/107873653/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/108004036/ccs 6089 Y Y scAAV full 1 -m64011_220616_211638/108004807/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/108069039/ccs/rev 4327 Y Y scAAV left-partial 1 -m64011_220616_211638/108070484/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/108135056/ccs 1216 Y N ssAAV right-partial 2 -m64011_220616_211638/108135062/ccs/fwd 4788 Y Y scAAV full 1 -m64011_220616_211638/108135204/ccs 4789 Y Y scAAV full 1 -m64011_220616_211638/108136646/ccs 2814 Y Y tandem vector+backbone|left-partial 1 -m64011_220616_211638/108201207/ccs/fwd 4704 Y Y scAAV full 1 -m64011_220616_211638/108333586/ccs 2370 Y N ssAAV full 2 -m64011_220616_211638/108333649/ccs/fwd 1778 Y Y scAAV right-partial 1 -m64011_220616_211638/108396664/ccs/fwd 2452 Y N ssAAV full 1 -m64011_220616_211638/108463947/ccs/fwd 2908 Y Y scAAV right-partial 1 -m64011_220616_211638/108464610/ccs 2435 Y N ssAAV full 2 -m64011_220616_211638/108464674/ccs 2410 Y Y scAAV full|right-partial 1 -m64011_220616_211638/108529500/ccs/fwd 5091 Y Y scAAV full 1 -m64011_220616_211638/108593724/ccs/rev 4366 Y Y scAAV right-partial 1 -m64011_220616_211638/108595775/ccs/rev 4710 Y Y scAAV full 1 -m64011_220616_211638/108660625/ccs/rev 3754 Y Y scAAV backbone 1 -m64011_220616_211638/108725430/ccs/rev 2159 Y Y scAAV partial 1 -m64011_220616_211638/109052667/ccs 591 Y Y repcap NA 1 -m64011_220616_211638/109053289/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/109118078/ccs 2894 Y Y scAAV right-partial 1 -m64011_220616_211638/109185784/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/109382011/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/109511317/ccs 3750 Y Y scAAV full|left-partial 1 -m64011_220616_211638/109512771/ccs 2393 Y N ssAAV full 2 -m64011_220616_211638/109576614/ccs/fwd 2931 Y Y scAAV right-partial 1 -m64011_220616_211638/109577395/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/109642373/ccs/rev 2407 Y Y tandem full|right-partial 1 -m64011_220616_211638/109709665/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/109773066/ccs 2361 Y Y scAAV partial 1 -m64011_220616_211638/109839115/ccs 2368 Y Y scAAV full|right-partial 1 -m64011_220616_211638/109971496/ccs/rev 4763 Y Y scAAV full 1 -m64011_220616_211638/109971555/ccs 4795 Y Y scAAV full 1 -m64011_220616_211638/109971929/ccs 1052 Y Y scAAV partial 1 -m64011_220616_211638/109972172/ccs/rev 4796 Y Y scAAV full 1 -m64011_220616_211638/110037464/ccs 1241 Y Y scAAV right-partial 1 -m64011_220616_211638/110037577/ccs/fwd 3231 N N NA NA 1 -m64011_220616_211638/110102864/ccs 4774 Y Y scAAV full 1 -m64011_220616_211638/110103377/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/110166573/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/110232513/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/110233993/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/110298869/ccs 2625 Y Y tandem full|right-partial 1 -m64011_220616_211638/110299122/ccs 2585 Y Y scAAV backbone|right-partial 1 -m64011_220616_211638/110299613/ccs 3257 Y Y scAAV right-partial 1 -m64011_220616_211638/110429181/ccs 1367 Y N host NA 1 -m64011_220616_211638/110625821/ccs 2532 Y N ssAAV full 2 -m64011_220616_211638/110627261/ccs 4788 Y Y scAAV full 1 -m64011_220616_211638/110691757/ccs 4787 Y Y scAAV full 1 -m64011_220616_211638/110692478/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/110822147/ccs/fwd 4787 Y Y scAAV full 1 -m64011_220616_211638/110824150/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/110887886/ccs 1961 Y N ssAAV right-partial 2 -m64011_220616_211638/110953002/ccs/fwd 4801 Y Y scAAV full 1 -m64011_220616_211638/111084240/ccs 7827 Y Y scAAV full 1 -m64011_220616_211638/111151576/ccs 2411 Y Y tandem full|right-partial 1 -m64011_220616_211638/111217195/ccs/fwd 2405 Y N ssAAV full 1 -m64011_220616_211638/111282017/ccs 1139 Y Y scAAV partial 1 -m64011_220616_211638/111479192/ccs/fwd 2370 Y Y scAAV full|right-partial 1 -m64011_220616_211638/111543385/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/111609452/ccs/fwd 5017 Y Y scAAV full 1 -m64011_220616_211638/111871059/ccs/fwd 3437 Y Y scAAV right-partial 1 -m64011_220616_211638/111871421/ccs 1454 Y Y scAAV right-partial 1 -m64011_220616_211638/111936590/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/112068190/ccs/fwd 4758 Y Y scAAV full 1 -m64011_220616_211638/112069453/ccs/fwd 4758 Y Y scAAV full 1 -m64011_220616_211638/112132619/ccs 2474 Y N ssAAV full 2 -m64011_220616_211638/112133276/ccs 503 Y Y scAAV right-partial 1 -m64011_220616_211638/112134362/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/112331498/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/112394707/ccs 4700 Y Y scAAV full 1 -m64011_220616_211638/112460754/ccs/rev 4801 Y Y scAAV full 1 -m64011_220616_211638/112525387/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/112525957/ccs 2409 Y N ssAAV full 2 -m64011_220616_211638/112526365/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/112591532/ccs 4276 Y N unclassified right-partial 1 -m64011_220616_211638/112593072/ccs 532 Y N ssAAV partial 2 -m64011_220616_211638/112657439/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/112789648/ccs 2428 Y N ssAAV full 2 -m64011_220616_211638/112853635/ccs 4585 Y Y scAAV full 1 -m64011_220616_211638/112919373/ccs/rev 2633 Y Y scAAV full|right-partial 1 -m64011_220616_211638/112986415/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/113049709/ccs/fwd 2651 Y Y host NA 1 -m64011_220616_211638/113052492/ccs/fwd 4312 Y Y scAAV right-partial 1 -m64011_220616_211638/113115498/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/113182077/ccs 4701 Y Y scAAV full 1 -m64011_220616_211638/113247150/ccs 588 Y N unclassified right-partial 1 -m64011_220616_211638/113313028/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/113313870/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/113378784/ccs 2223 Y N ssAAV left-partial 2 -m64011_220616_211638/113379539/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/113442947/ccs 2413 Y Y scAAV full|right-partial 1 -m64011_220616_211638/113443897/ccs 5582 Y Y scAAV backbone 1 -m64011_220616_211638/113574374/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/113575496/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/113576245/ccs/fwd 3573 Y Y scAAV right-partial 1 -m64011_220616_211638/113639719/ccs 1073 Y Y scAAV right-partial 1 -m64011_220616_211638/113770887/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/113836792/ccs/fwd 3574 Y Y scAAV right-partial 1 -m64011_220616_211638/113837000/ccs 4696 Y Y scAAV full 1 -m64011_220616_211638/113903513/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/113904323/ccs/fwd 2383 Y Y tandem full|right-partial 1 -m64011_220616_211638/113904341/ccs 2826 Y Y scAAV right-partial 1 -m64011_220616_211638/114033681/ccs/fwd 4776 Y Y scAAV full 1 -m64011_220616_211638/114034588/ccs 3412 Y Y scAAV left-partial 1 -m64011_220616_211638/114100545/ccs/rev 4892 Y Y scAAV full 1 -m64011_220616_211638/114295250/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/114361190/ccs 1508 Y Y scAAV left-partial 1 -m64011_220616_211638/114426572/ccs 3568 Y Y scAAV right-partial 1 -m64011_220616_211638/114427319/ccs 4638 Y Y scAAV full 1 -m64011_220616_211638/114427363/ccs/rev 3734 Y Y scAAV right-partial 1 -m64011_220616_211638/114491925/ccs 718 Y Y scAAV left-partial 1 -m64011_220616_211638/114556975/ccs 1722 Y N ssAAV left-partial 2 -m64011_220616_211638/114623000/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/114624252/ccs/fwd 4508 Y Y scAAV left-partial 1 -m64011_220616_211638/114624557/ccs 2107 Y N ssAAV left-partial 2 -m64011_220616_211638/114688528/ccs 1213 Y N ssAAV right-partial 2 -m64011_220616_211638/114689342/ccs 2375 Y N ssAAV full 2 -m64011_220616_211638/114754400/ccs/fwd 3571 Y Y scAAV right-partial 1 -m64011_220616_211638/114755222/ccs 2409 Y Y scAAV full|right-partial 1 -m64011_220616_211638/114821078/ccs/rev 4797 Y Y scAAV full 1 -m64011_220616_211638/114886203/ccs/rev 4792 Y Y scAAV full 1 -m64011_220616_211638/115016453/ccs 3869 Y Y repcap NA 1 -m64011_220616_211638/115017518/ccs 4700 Y Y scAAV full 1 -m64011_220616_211638/115018535/ccs 2394 Y Y scAAV full|right-partial 1 -m64011_220616_211638/115083399/ccs 2375 Y Y scAAV full|right-partial 1 -m64011_220616_211638/115083626/ccs 3344 Y Y scAAV right-partial 1 -m64011_220616_211638/115147117/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/115148819/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/115213044/ccs 531 Y Y scAAV right-partial 1 -m64011_220616_211638/115214464/ccs 2466 Y N ssAAV full 2 -m64011_220616_211638/115278361/ccs/rev 4777 Y Y scAAV full 1 -m64011_220616_211638/115475030/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/115803765/ccs/fwd 4778 Y Y scAAV full 1 -m64011_220616_211638/116064864/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/116392544/ccs 2211 Y N ssAAV right-partial 2 -m64011_220616_211638/116459807/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/116654239/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/116785327/ccs 1607 Y Y scAAV right-partial 1 -m64011_220616_211638/116787798/ccs/fwd 4786 Y Y scAAV full 1 -m64011_220616_211638/116853056/ccs 2441 Y N ssAAV full 2 -m64011_220616_211638/116916683/ccs 2425 Y N ssAAV full 2 -m64011_220616_211638/116982467/ccs 2369 Y N ssAAV full 2 -m64011_220616_211638/116982802/ccs 4461 Y Y scAAV right-partial 1 -m64011_220616_211638/116982955/ccs 3685 Y Y scAAV right-partial 1 -m64011_220616_211638/116983221/ccs/rev 4143 Y Y scAAV partial 1 -m64011_220616_211638/116983621/ccs 685 N N NA NA 1 -m64011_220616_211638/117048944/ccs 2329 Y N ssAAV full 2 -m64011_220616_211638/117049663/ccs/fwd 4779 Y Y scAAV full 1 -m64011_220616_211638/117113572/ccs 2428 Y N ssAAV full 2 -m64011_220616_211638/117178875/ccs/fwd 4354 Y Y scAAV left-partial 1 -m64011_220616_211638/117179900/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/117180307/ccs/rev 3586 Y Y scAAV left-partial 1 -m64011_220616_211638/117245775/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/117311423/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/117508421/ccs 3363 Y Y scAAV right-partial 1 -m64011_220616_211638/117572863/ccs 4795 Y Y scAAV full 1 -m64011_220616_211638/117639614/ccs 2435 Y N ssAAV full 2 -m64011_220616_211638/117639860/ccs/rev 4701 Y Y scAAV full 1 -m64011_220616_211638/117834496/ccs 2189 Y N ssAAV right-partial 2 -m64011_220616_211638/117835426/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/117965847/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/118032959/ccs/rev 2030 Y N ssAAV right-partial 1 -m64011_220616_211638/118096663/ccs 2439 Y N ssAAV full 2 -m64011_220616_211638/118163514/ccs/fwd 1270 Y N ssAAV right-partial 1 -m64011_220616_211638/118229113/ccs 4762 Y Y scAAV full 1 -m64011_220616_211638/118292791/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/118294941/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/118424788/ccs/rev 603 Y Y scAAV left-partial 1 -m64011_220616_211638/118425255/ccs/rev 4775 Y Y scAAV full 1 -m64011_220616_211638/118426254/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/118490981/ccs 1723 Y Y scAAV partial 1 -m64011_220616_211638/118555098/ccs 2528 Y N ssAAV full 2 -m64011_220616_211638/118556820/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/118686470/ccs 1200 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/118686724/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/118753274/ccs 802 Y N ssAAV partial 2 -m64011_220616_211638/118753558/ccs/fwd 1595 Y N ssAAV right-partial 1 -m64011_220616_211638/118753740/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/118817074/ccs/rev 402 Y Y scAAV right-partial 1 -m64011_220616_211638/118883584/ccs 2910 Y Y scAAV right-partial 1 -m64011_220616_211638/118948882/ccs 4700 Y Y scAAV full 1 -m64011_220616_211638/119013535/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/119014857/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/119015702/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/119016202/ccs/rev 4795 Y Y scAAV full 1 -m64011_220616_211638/119080192/ccs 4746 Y Y scAAV full 1 -m64011_220616_211638/119081764/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/119146424/ccs/rev 2841 N N NA NA 1 -m64011_220616_211638/119146543/ccs/rev 2207 Y N ssAAV right-partial 1 -m64011_220616_211638/119275669/ccs/fwd 4701 Y Y scAAV full 1 -m64011_220616_211638/119537931/ccs/rev 4677 Y Y scAAV full 1 -m64011_220616_211638/119538650/ccs/rev 2448 Y N ssAAV full 1 -m64011_220616_211638/119603297/ccs 2439 Y N ssAAV full 2 -m64011_220616_211638/119604581/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/119605540/ccs 4777 Y Y scAAV full 1 -m64011_220616_211638/119734640/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/119736330/ccs 576 Y N ssAAV partial 2 -m64011_220616_211638/119800498/ccs/rev 4694 Y Y scAAV full 1 -m64011_220616_211638/119866265/ccs/rev 4786 Y Y scAAV full 1 -m64011_220616_211638/119866273/ccs 4713 Y Y scAAV full 1 -m64011_220616_211638/119932737/ccs 1166 Y Y scAAV right-partial 1 -m64011_220616_211638/119997651/ccs 2408 Y Y scAAV full|right-partial 1 -m64011_220616_211638/119997906/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/119998570/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/120062534/ccs/fwd 2414 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/120127509/ccs 2465 Y N ssAAV full 2 -m64011_220616_211638/120259173/ccs/rev 959 Y Y scAAV right-partial 1 -m64011_220616_211638/120259524/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/120325271/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/120456953/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/120457022/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/120457826/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/120522739/ccs/rev 4619 Y Y scAAV full 1 -m64011_220616_211638/120586307/ccs/fwd 4755 Y Y scAAV full 1 -m64011_220616_211638/120586358/ccs/fwd 2740 Y Y scAAV right-partial 1 -m64011_220616_211638/120587594/ccs/fwd 2452 Y N ssAAV full 1 -m64011_220616_211638/120719710/ccs/rev 785 Y N ssAAV right-partial 1 -m64011_220616_211638/120850400/ccs/rev 2199 Y N ssAAV right-partial 1 -m64011_220616_211638/120850815/ccs 1859 Y N ssAAV right-partial 2 -m64011_220616_211638/120982171/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/121045339/ccs 2207 Y N ssAAV right-partial 2 -m64011_220616_211638/121047795/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/121112373/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/121112564/ccs 2478 Y N ssAAV full 2 -m64011_220616_211638/121113157/ccs/rev 3572 Y Y scAAV right-partial 1 -m64011_220616_211638/121243552/ccs 4751 Y Y scAAV full 1 -m64011_220616_211638/121244339/ccs/fwd 2468 Y N ssAAV full 1 -m64011_220616_211638/121307248/ccs 2482 Y N ssAAV full 2 -m64011_220616_211638/121308481/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/121309593/ccs 4904 Y Y scAAV full 1 -m64011_220616_211638/121440692/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/121440796/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/121503783/ccs 4770 Y Y scAAV full 1 -m64011_220616_211638/121505057/ccs/fwd 4306 Y Y scAAV right-partial 1 -m64011_220616_211638/121636282/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/121701429/ccs 2471 Y N ssAAV full 2 -m64011_220616_211638/121766932/ccs 5040 Y Y tandem vector+backbone|left-partial 1 -m64011_220616_211638/121767281/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/121767760/ccs 4734 Y Y scAAV full 1 -m64011_220616_211638/121768106/ccs/rev 1128 Y Y scAAV right-partial 1 -m64011_220616_211638/121833501/ccs/fwd 4770 Y Y scAAV full 1 -m64011_220616_211638/121898265/ccs 545 Y Y scAAV right-partial 1 -m64011_220616_211638/121962876/ccs 2362 Y N ssAAV full 2 -m64011_220616_211638/121963552/ccs 862 Y N ssAAV right-partial 2 -m64011_220616_211638/121964086/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/122028534/ccs 2446 Y N ssAAV full 2 -m64011_220616_211638/122030119/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/122094053/ccs 2105 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/122094674/ccs 2210 Y N ssAAV right-partial 2 -m64011_220616_211638/122095143/ccs 2875 Y Y scAAV right-partial 1 -m64011_220616_211638/122160940/ccs 2220 Y N ssAAV right-partial 2 -m64011_220616_211638/122225077/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/122290326/ccs 1277 Y Y scAAV partial 1 -m64011_220616_211638/122291184/ccs/fwd 4790 Y Y scAAV full 1 -m64011_220616_211638/122355934/ccs 4767 Y Y scAAV full 1 -m64011_220616_211638/122357392/ccs 4682 Y Y scAAV full 1 -m64011_220616_211638/122358393/ccs 1470 Y Y scAAV left-partial 1 -m64011_220616_211638/122421579/ccs 2385 Y N ssAAV full 2 -m64011_220616_211638/122421801/ccs/rev 4784 Y Y scAAV full 1 -m64011_220616_211638/122422755/ccs 1374 Y Y scAAV right-partial 1 -m64011_220616_211638/122423611/ccs/rev 4356 Y Y scAAV right-partial 1 -m64011_220616_211638/122552368/ccs 2466 Y N ssAAV full 2 -m64011_220616_211638/122553167/ccs/fwd 2468 Y Y scAAV partial 1 -m64011_220616_211638/122685471/ccs 1621 Y N ssAAV right-partial 2 -m64011_220616_211638/122814734/ccs/fwd 529 Y Y scAAV right-partial 1 -m64011_220616_211638/122815452/ccs/fwd 1964 Y Y scAAV left-partial 1 -m64011_220616_211638/123011182/ccs/fwd 2387 Y N ssAAV right-partial 1 -m64011_220616_211638/123078542/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/123078945/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/123143215/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/123208625/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/123209890/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/123338811/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/123405401/ccs 2479 Y N ssAAV full 2 -m64011_220616_211638/123471089/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/123471201/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/123471695/ccs/fwd 2454 Y N ssAAV full 1 -m64011_220616_211638/123535765/ccs/fwd 4805 Y Y scAAV full 1 -m64011_220616_211638/123535770/ccs 2391 Y Y tandem full|right-partial 1 -m64011_220616_211638/123536968/ccs 4734 Y Y scAAV full 1 -m64011_220616_211638/123602492/ccs 348 Y Y scAAV partial 1 -m64011_220616_211638/123667929/ccs 2426 Y N ssAAV full 2 -m64011_220616_211638/123733395/ccs/fwd 4902 Y Y scAAV full 1 -m64011_220616_211638/123733403/ccs/fwd 4792 Y Y scAAV full 1 -m64011_220616_211638/123797955/ccs/rev 1511 Y Y tandem left-partial 1 -m64011_220616_211638/123800192/ccs 3292 Y Y scAAV right-partial 1 -m64011_220616_211638/123930724/ccs 4861 Y Y scAAV full 1 -m64011_220616_211638/123995368/ccs/fwd 2379 Y N ssAAV full 1 -m64011_220616_211638/123995734/ccs/fwd 4701 Y Y scAAV full 1 -m64011_220616_211638/123996923/ccs 4285 Y Y scAAV right-partial 1 -m64011_220616_211638/124061864/ccs/rev 3806 Y Y scAAV left-partial 1 -m64011_220616_211638/124125489/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/124126449/ccs 4768 Y Y scAAV full 1 -m64011_220616_211638/124127453/ccs/fwd 4927 Y Y scAAV full 1 -m64011_220616_211638/124259153/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/124518900/ccs 4025 Y Y scAAV right-partial 1 -m64011_220616_211638/124586135/ccs 936 Y N ssAAV left-partial 2 -m64011_220616_211638/124650147/ccs 3468 Y Y scAAV full|left-partial 1 -m64011_220616_211638/124715726/ccs 2413 Y N ssAAV full 2 -m64011_220616_211638/124716068/ccs/fwd 4699 Y Y scAAV full 1 -m64011_220616_211638/124716312/ccs 3223 Y Y scAAV partial 1 -m64011_220616_211638/124717426/ccs/rev 4738 Y Y scAAV full 1 -m64011_220616_211638/124846921/ccs/fwd 5927 Y Y scAAV full 1 -m64011_220616_211638/124977925/ccs 4768 Y Y scAAV full 1 -m64011_220616_211638/124978653/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/124979696/ccs 3439 Y Y scAAV right-partial 1 -m64011_220616_211638/124979851/ccs/fwd 4763 Y Y scAAV full 1 -m64011_220616_211638/125109157/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/125239871/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/125241036/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/125306685/ccs 2410 Y N ssAAV full 2 -m64011_220616_211638/125436093/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/125437623/ccs 1878 Y N ssAAV right-partial 2 -m64011_220616_211638/125437971/ccs 2052 Y Y scAAV right-partial 1 -m64011_220616_211638/125438348/ccs/fwd 2783 Y Y scAAV right-partial 1 -m64011_220616_211638/125633080/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/125633118/ccs 2167 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/125633757/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/125700321/ccs 2371 Y Y tandem full|right-partial 1 -m64011_220616_211638/125764247/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/125765809/ccs 657 Y N ssAAV right-partial 2 -m64011_220616_211638/125765974/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/125831473/ccs 2178 Y N ssAAV full 2 -m64011_220616_211638/125831690/ccs 4699 Y Y scAAV full 1 -m64011_220616_211638/125832030/ccs 2135 Y N ssAAV right-partial 2 -m64011_220616_211638/125894675/ccs 2372 Y Y scAAV full|right-partial 1 -m64011_220616_211638/125895086/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/125896317/ccs/fwd 2569 Y N ssAAV right-partial 1 -m64011_220616_211638/125896406/ccs 4926 Y Y scAAV full 1 -m64011_220616_211638/126026856/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/126028080/ccs 1193 Y Y scAAV right-partial 1 -m64011_220616_211638/126159048/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/126159632/ccs 3576 Y Y scAAV full|right-partial 1 -m64011_220616_211638/126224412/ccs 2273 Y N ssAAV full 2 -m64011_220616_211638/126288149/ccs 2421 Y N ssAAV full 2 -m64011_220616_211638/126290293/ccs/rev 4686 Y Y scAAV full 1 -m64011_220616_211638/126421574/ccs/rev 4775 Y Y scAAV full 1 -m64011_220616_211638/126550312/ccs/rev 2813 Y Y scAAV right-partial 1 -m64011_220616_211638/126683539/ccs 2351 Y N ssAAV right-partial 2 -m64011_220616_211638/126813276/ccs/fwd 2370 Y Y scAAV full|right-partial 1 -m64011_220616_211638/126814104/ccs 4273 Y Y scAAV right-partial 1 -m64011_220616_211638/126879824/ccs 2389 Y N ssAAV full 2 -m64011_220616_211638/126880548/ccs 4091 Y Y scAAV full|right-partial 1 -m64011_220616_211638/126880578/ccs 2412 Y N ssAAV full 2 -m64011_220616_211638/126945874/ccs/rev 4757 Y Y scAAV full 1 -m64011_220616_211638/126945910/ccs/rev 2369 Y N ssAAV full 1 -m64011_220616_211638/127075108/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/127142392/ccs 1310 Y Y scAAV right-partial 1 -m64011_220616_211638/127206509/ccs 2083 Y Y tandem right-partial 1 -m64011_220616_211638/127207998/ccs 1205 Y Y scAAV right-partial 1 -m64011_220616_211638/127208107/ccs/rev 4699 Y Y scAAV full 1 -m64011_220616_211638/127337051/ccs 4697 Y Y scAAV full 1 -m64011_220616_211638/127337442/ccs 2504 Y N ssAAV full 2 -m64011_220616_211638/127403604/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/127468620/ccs 3549 Y Y scAAV right-partial 1 -m64011_220616_211638/127533975/ccs 1155 Y N ssAAV right-partial 2 -m64011_220616_211638/127599640/ccs 4804 Y Y scAAV full 1 -m64011_220616_211638/127599661/ccs 1111 Y N ssAAV left-partial 2 -m64011_220616_211638/127599808/ccs 3414 Y Y scAAV right-partial 1 -m64011_220616_211638/127665118/ccs 3461 Y Y scAAV right-partial 1 -m64011_220616_211638/127665881/ccs/fwd 4785 Y Y scAAV full 1 -m64011_220616_211638/127666169/ccs 4770 Y Y scAAV full 1 -m64011_220616_211638/127666742/ccs 2424 Y Y tandem full|right-partial 1 -m64011_220616_211638/127862180/ccs/rev 2529 Y N ssAAV right-partial 1 -m64011_220616_211638/127926938/ccs/fwd 3595 Y Y scAAV left-partial 1 -m64011_220616_211638/127927646/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/127992421/ccs 4587 Y Y scAAV full|right-partial 1 -m64011_220616_211638/127992676/ccs 2412 Y Y scAAV full|right-partial 1 -m64011_220616_211638/127994169/ccs/rev 4787 Y Y scAAV full 1 -m64011_220616_211638/128058104/ccs 1266 Y Y scAAV right-partial 1 -m64011_220616_211638/128123076/ccs/fwd 4699 Y Y scAAV full 1 -m64011_220616_211638/128189096/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/128189187/ccs 3218 Y Y scAAV right-partial 1 -m64011_220616_211638/128255337/ccs 1551 Y N ssAAV partial 2 -m64011_220616_211638/128387472/ccs/rev 4692 Y Y scAAV full 1 -m64011_220616_211638/128451500/ccs 2370 Y N ssAAV full 2 -m64011_220616_211638/128516491/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/128582307/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/128648127/ccs 2476 Y N ssAAV full 2 -m64011_220616_211638/128648825/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/128778422/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/128779764/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/128844672/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/128845586/ccs 1470 Y N unclassified right-partial 1 -m64011_220616_211638/128976253/ccs/fwd 1105 Y Y scAAV right-partial 1 -m64011_220616_211638/129041500/ccs 4789 Y Y scAAV full 1 -m64011_220616_211638/129106789/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/129107238/ccs 7068 Y Y scAAV full 1 -m64011_220616_211638/129107694/ccs 4669 Y Y scAAV full 1 -m64011_220616_211638/129108334/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/129108814/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/129239600/ccs 2552 Y N unclassified right-partial 1 -m64011_220616_211638/129303094/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/129303925/ccs 2372 Y N ssAAV full 2 -m64011_220616_211638/129304491/ccs 2583 Y N ssAAV full 2 -m64011_220616_211638/129304931/ccs/fwd 2453 Y N ssAAV full 1 -m64011_220616_211638/129370125/ccs 2033 Y N ssAAV left-partial 2 -m64011_220616_211638/129370215/ccs/fwd 4952 Y Y scAAV full 1 -m64011_220616_211638/129370677/ccs 2372 Y Y scAAV full|right-partial 1 -m64011_220616_211638/129435937/ccs 2355 Y N unclassified right-partial 1 -m64011_220616_211638/129500736/ccs 2542 Y Y scAAV partial 1 -m64011_220616_211638/129565548/ccs 4806 Y Y scAAV full 1 -m64011_220616_211638/129566417/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/129566705/ccs 2079 Y N ssAAV right-partial 2 -m64011_220616_211638/129632718/ccs/rev 4702 Y Y scAAV full 1 -m64011_220616_211638/129633087/ccs/rev 2431 Y Y tandem full|right-partial 1 -m64011_220616_211638/129697149/ccs 3700 Y Y scAAV left-partial 1 -m64011_220616_211638/129697998/ccs 2476 Y N ssAAV full 2 -m64011_220616_211638/129762331/ccs 2375 Y Y scAAV full|right-partial 1 -m64011_220616_211638/129827105/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/129827765/ccs 2470 Y N ssAAV full 2 -m64011_220616_211638/129892591/ccs 3439 Y Y scAAV left-partial 1 -m64011_220616_211638/129957985/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/129957993/ccs 2370 Y Y tandem full|right-partial 1 -m64011_220616_211638/130024499/ccs/fwd 4764 Y Y scAAV full 1 -m64011_220616_211638/130026022/ccs/fwd 798 Y Y scAAV right-partial 1 -m64011_220616_211638/130089441/ccs/fwd 4728 Y Y scAAV full 1 -m64011_220616_211638/130090591/ccs/rev 3300 Y Y scAAV full 1 -m64011_220616_211638/130154640/ccs/fwd 1664 Y Y tandem left-partial 1 -m64011_220616_211638/130155277/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/130220675/ccs 2412 Y Y scAAV full|right-partial 1 -m64011_220616_211638/130222731/ccs/fwd 4776 Y Y scAAV full 1 -m64011_220616_211638/130285963/ccs 2323 Y N ssAAV right-partial 2 -m64011_220616_211638/130286211/ccs 2445 Y N ssAAV full 2 -m64011_220616_211638/130351861/ccs 4786 Y Y scAAV full 1 -m64011_220616_211638/130417093/ccs 4699 Y Y scAAV full 1 -m64011_220616_211638/130482645/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/130550274/ccs 3144 Y Y scAAV backbone 1 -m64011_220616_211638/130810782/ccs 2218 Y Y tandem vector+backbone|right-partial 1 -m64011_220616_211638/130876575/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/130876597/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/130877360/ccs/rev 2424 Y N ssAAV full 1 -m64011_220616_211638/130877391/ccs/rev 4847 Y Y scAAV full 1 -m64011_220616_211638/130941455/ccs/fwd 4889 Y Y scAAV full 1 -m64011_220616_211638/131006696/ccs 3096 Y Y tandem full|left-partial 1 -m64011_220616_211638/131006860/ccs/rev 4816 Y Y scAAV full 1 -m64011_220616_211638/131008941/ccs/rev 2452 Y N ssAAV full 1 -m64011_220616_211638/131009106/ccs/rev 4839 Y Y scAAV full 1 -m64011_220616_211638/131074063/ccs/fwd 4800 Y Y scAAV full 1 -m64011_220616_211638/131138503/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/131139907/ccs/rev 2838 Y Y scAAV right-partial 1 -m64011_220616_211638/131203442/ccs 4760 Y Y scAAV full 1 -m64011_220616_211638/131203560/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/131205763/ccs 3437 Y Y scAAV right-partial 1 -m64011_220616_211638/131270558/ccs 3281 Y Y scAAV right-partial 1 -m64011_220616_211638/131400244/ccs 2676 Y Y scAAV left-partial 1 -m64011_220616_211638/131597006/ccs 1914 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/131597592/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/131597941/ccs/rev 4767 Y Y scAAV full 1 -m64011_220616_211638/131794743/ccs/rev 4817 Y Y scAAV full 1 -m64011_220616_211638/131859794/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/131860090/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/131990469/ccs 1257 Y Y repcap NA 1 -m64011_220616_211638/131992083/ccs/fwd 4763 Y Y scAAV full 1 -m64011_220616_211638/132055595/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/132252094/ccs/rev 4760 Y Y scAAV full 1 -m64011_220616_211638/132252235/ccs/fwd 3975 Y Y scAAV right-partial 1 -m64011_220616_211638/132252696/ccs 2575 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/132253698/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/132254478/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/132319459/ccs 4072 N N NA NA 1 -m64011_220616_211638/132449594/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/132449600/ccs 2820 Y Y scAAV left-partial|right-partial 1 -m64011_220616_211638/132516637/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/132580036/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/132580824/ccs 2475 Y N ssAAV full 2 -m64011_220616_211638/132645142/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/132645541/ccs/fwd 3570 Y Y scAAV right-partial 1 -m64011_220616_211638/132645608/ccs/rev 2484 Y N unclassified backbone 1 -m64011_220616_211638/132645816/ccs/fwd 2454 Y N ssAAV full 1 -m64011_220616_211638/132710685/ccs 4534 Y Y scAAV full|left-partial 1 -m64011_220616_211638/132713164/ccs 2369 Y Y tandem full|right-partial 1 -m64011_220616_211638/132776957/ccs/rev 4800 Y Y scAAV full 1 -m64011_220616_211638/132777206/ccs 2467 Y N ssAAV full 2 -m64011_220616_211638/132778331/ccs 1086 Y Y scAAV partial 1 -m64011_220616_211638/132843266/ccs 4706 Y Y scAAV full 1 -m64011_220616_211638/132844171/ccs/rev 2410 Y Y tandem full|right-partial 1 -m64011_220616_211638/132844193/ccs/rev 4788 Y Y scAAV full 1 -m64011_220616_211638/133039244/ccs 2424 Y N ssAAV full 2 -m64011_220616_211638/133103795/ccs/rev 2410 Y N ssAAV full 1 -m64011_220616_211638/133104085/ccs 1121 Y N ssAAV right-partial 2 -m64011_220616_211638/133104308/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/133104339/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/133104754/ccs/rev 4680 Y Y scAAV full 1 -m64011_220616_211638/133105490/ccs/fwd 4780 Y Y scAAV full 1 -m64011_220616_211638/133170817/ccs 2327 Y N ssAAV full 2 -m64011_220616_211638/133171959/ccs 2406 Y N ssAAV full 2 -m64011_220616_211638/133236394/ccs 2471 Y N ssAAV full 2 -m64011_220616_211638/133236503/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/133300724/ccs/fwd 2660 Y N ssAAV right-partial 1 -m64011_220616_211638/133302044/ccs/rev 3436 Y Y scAAV right-partial 1 -m64011_220616_211638/133367675/ccs 2058 Y Y scAAV right-partial 1 -m64011_220616_211638/133564547/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/133564761/ccs 2545 Y N ssAAV right-partial 2 -m64011_220616_211638/133628996/ccs 4775 Y Y scAAV full 1 -m64011_220616_211638/133696179/ccs 785 Y Y scAAV left-partial 1 -m64011_220616_211638/133760310/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/133825144/ccs 2201 Y N ssAAV right-partial 2 -m64011_220616_211638/133825865/ccs 2251 Y N ssAAV full 2 -m64011_220616_211638/133826608/ccs/fwd 4967 Y Y scAAV full 1 -m64011_220616_211638/133890763/ccs/rev 4775 Y Y scAAV full 1 -m64011_220616_211638/133891489/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/133891886/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/133892808/ccs 2477 Y Y scAAV full|right-partial 1 -m64011_220616_211638/133956445/ccs/fwd 4780 Y Y scAAV full 1 -m64011_220616_211638/133956488/ccs 4747 Y N unclassified full 1 -m64011_220616_211638/133957462/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/133958460/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/134022912/ccs 2477 Y N ssAAV full 2 -m64011_220616_211638/134023011/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/134024010/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/134153568/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/134153711/ccs 1381 Y N ssAAV left-partial 2 -m64011_220616_211638/134351220/ccs 2405 Y N ssAAV full 2 -m64011_220616_211638/134479993/ccs/rev 2495 Y N ssAAV full 1 -m64011_220616_211638/134546090/ccs/rev 3573 Y Y scAAV right-partial 1 -m64011_220616_211638/134613425/ccs 3606 Y Y scAAV right-partial 1 -m64011_220616_211638/134676923/ccs 421 Y Y scAAV left-partial 1 -m64011_220616_211638/134677855/ccs 1280 Y N ssAAV partial 2 -m64011_220616_211638/134677891/ccs/rev 4783 Y Y scAAV full 1 -m64011_220616_211638/134677933/ccs/rev 2407 Y N ssAAV full 1 -m64011_220616_211638/134808146/ccs 2468 Y N ssAAV full 2 -m64011_220616_211638/134874167/ccs/fwd 2454 Y N ssAAV full 1 -m64011_220616_211638/134874658/ccs 750 Y N ssAAV right-partial 2 -m64011_220616_211638/134941470/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/135070498/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/135072078/ccs/fwd 3435 Y Y scAAV right-partial 1 -m64011_220616_211638/135201859/ccs/rev 1723 Y Y scAAV right-partial 1 -m64011_220616_211638/135202798/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/135203191/ccs 1464 Y Y scAAV partial 1 -m64011_220616_211638/135267747/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/135333359/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/135398699/ccs/fwd 4779 Y Y scAAV full 1 -m64011_220616_211638/135399612/ccs/fwd 3835 Y Y scAAV vector+backbone 1 -m64011_220616_211638/135463214/ccs/fwd 1239 Y Y scAAV right-partial 1 -m64011_220616_211638/135464357/ccs 4802 Y Y scAAV full 1 -m64011_220616_211638/135465823/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/135530766/ccs/fwd 3505 Y Y scAAV right-partial 1 -m64011_220616_211638/135660982/ccs/fwd 4705 Y Y scAAV full|left-partial 1 -m64011_220616_211638/135727536/ccs 4713 Y Y scAAV full 1 -m64011_220616_211638/135791446/ccs 2475 Y N ssAAV full 2 -m64011_220616_211638/135856821/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/135858973/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/135989306/ccs 2497 Y Y scAAV full|right-partial 1 -m64011_220616_211638/136054087/ccs 4724 Y Y scAAV full 1 -m64011_220616_211638/136118657/ccs 2503 Y N ssAAV full 2 -m64011_220616_211638/136121070/ccs 3433 Y Y scAAV right-partial 1 -m64011_220616_211638/136184386/ccs 4790 Y Y scAAV full 1 -m64011_220616_211638/136186298/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/136251134/ccs/fwd 4779 Y Y scAAV full 1 -m64011_220616_211638/136251261/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/136251690/ccs 4765 Y Y scAAV full 1 -m64011_220616_211638/136381342/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/136381573/ccs 3678 Y Y scAAV full|right-partial 1 -m64011_220616_211638/136382416/ccs/fwd 1299 Y N ssAAV left-partial 1 -m64011_220616_211638/136447263/ccs 4673 Y Y scAAV full 1 -m64011_220616_211638/136511969/ccs 3847 Y Y scAAV right-partial 1 -m64011_220616_211638/136577968/ccs/rev 2697 Y Y scAAV left-partial 1 -m64011_220616_211638/136579928/ccs/rev 4966 Y Y scAAV full 1 -m64011_220616_211638/136644039/ccs/rev 3440 Y Y scAAV right-partial 1 -m64011_220616_211638/136644415/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/136645158/ccs 1650 Y Y scAAV backbone 1 -m64011_220616_211638/136710418/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/136774573/ccs 4762 Y Y scAAV full 1 -m64011_220616_211638/136775342/ccs 1240 Y N ssAAV left-partial 2 -m64011_220616_211638/136776193/ccs/fwd 3263 Y Y scAAV right-partial 1 -m64011_220616_211638/136905756/ccs 3064 Y Y scAAV right-partial 1 -m64011_220616_211638/136905948/ccs 1680 Y Y scAAV left-partial 1 -m64011_220616_211638/136971299/ccs 2432 Y N ssAAV full 2 -m64011_220616_211638/136973029/ccs 2409 Y Y tandem full|right-partial 1 -m64011_220616_211638/137037811/ccs/rev 4775 Y Y scAAV full 1 -m64011_220616_211638/137102386/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/137167528/ccs 2075 Y N ssAAV partial 2 -m64011_220616_211638/137167600/ccs/fwd 1145 Y N unclassified right-partial 1 -m64011_220616_211638/137169004/ccs/fwd 5279 Y Y scAAV full 1 -m64011_220616_211638/137234359/ccs 2490 Y N ssAAV full 2 -m64011_220616_211638/137234689/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/137496236/ccs/fwd 2447 Y N ssAAV full 1 -m64011_220616_211638/137496451/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/137496944/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/137560671/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/137626021/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/137626200/ccs 4612 Y Y scAAV full 1 -m64011_220616_211638/137626625/ccs/fwd 1623 Y Y scAAV right-partial 1 -m64011_220616_211638/137627805/ccs 2440 Y N ssAAV full 2 -m64011_220616_211638/137692033/ccs 3571 Y Y scAAV right-partial 1 -m64011_220616_211638/137888004/ccs/fwd 1545 Y Y tandem left-partial 1 -m64011_220616_211638/137889993/ccs 4786 Y Y scAAV full 1 -m64011_220616_211638/138020522/ccs/rev 4695 Y Y scAAV full 1 -m64011_220616_211638/138021176/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/138151183/ccs/fwd 2454 Y N ssAAV full 1 -m64011_220616_211638/138151316/ccs/fwd 4718 Y Y scAAV full 1 -m64011_220616_211638/138151456/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/138151488/ccs 3429 Y Y scAAV right-partial 1 -m64011_220616_211638/138151725/ccs 2270 Y N ssAAV right-partial 2 -m64011_220616_211638/138215744/ccs/rev 826 Y Y scAAV right-partial 1 -m64011_220616_211638/138216777/ccs 3678 Y Y scAAV right-partial 1 -m64011_220616_211638/138218098/ccs/rev 3585 Y Y scAAV left-partial 1 -m64011_220616_211638/138282157/ccs 4754 Y Y scAAV full 1 -m64011_220616_211638/138283387/ccs/rev 1333 Y Y scAAV left-partial 1 -m64011_220616_211638/138347063/ccs/rev 4888 Y Y scAAV full 1 -m64011_220616_211638/138348700/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/138348727/ccs 4692 Y Y scAAV full 1 -m64011_220616_211638/138412153/ccs 2739 Y Y scAAV right-partial 1 -m64011_220616_211638/138477638/ccs/rev 2411 Y Y tandem full|right-partial 1 -m64011_220616_211638/138477698/ccs 2501 Y N ssAAV full 2 -m64011_220616_211638/138477757/ccs 3436 Y Y scAAV right-partial 1 -m64011_220616_211638/138479739/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/138545007/ccs 4900 Y Y scAAV full 1 -m64011_220616_211638/138545029/ccs/rev 4696 Y Y scAAV full 1 -m64011_220616_211638/138805879/ccs/fwd 2325 Y Y scAAV left-partial 1 -m64011_220616_211638/138806959/ccs 1701 Y Y scAAV left-partial|right-partial 1 -m64011_220616_211638/138807177/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/138872822/ccs 3440 Y Y scAAV right-partial 1 -m64011_220616_211638/138936424/ccs 2378 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/138937515/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/138937953/ccs/rev 4658 Y Y scAAV full 1 -m64011_220616_211638/139003898/ccs 4765 Y Y scAAV full 1 -m64011_220616_211638/139004173/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/139134204/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/139199555/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/139265165/ccs/rev 4819 Y Y scAAV full 1 -m64011_220616_211638/139265310/ccs 2522 Y N ssAAV full 2 -m64011_220616_211638/139266319/ccs 2886 Y Y scAAV right-partial 1 -m64011_220616_211638/139330437/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/139330832/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/139331768/ccs/rev 4778 Y Y scAAV full 1 -m64011_220616_211638/139395808/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/139396025/ccs/fwd 2670 Y N ssAAV right-partial 1 -m64011_220616_211638/139461776/ccs/fwd 2976 Y Y scAAV right-partial 1 -m64011_220616_211638/139462227/ccs/fwd 3816 Y Y scAAV right-partial 1 -m64011_220616_211638/139592405/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/139659779/ccs/rev 2899 N N NA NA 1 -m64011_220616_211638/139724284/ccs/rev 4769 Y Y scAAV full 1 -m64011_220616_211638/139724734/ccs/fwd 2907 Y N ssAAV right-partial 1 -m64011_220616_211638/139724783/ccs 2513 Y Y scAAV full|right-partial 1 -m64011_220616_211638/139789649/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/139790447/ccs/fwd 4240 Y Y scAAV left-partial 1 -m64011_220616_211638/139919477/ccs 4775 Y Y scAAV full 1 -m64011_220616_211638/139919912/ccs 4562 Y Y scAAV full 1 -m64011_220616_211638/139921112/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/139921460/ccs 2413 Y N ssAAV full 2 -m64011_220616_211638/139922211/ccs 2402 Y N ssAAV full 2 -m64011_220616_211638/139986206/ccs 4911 Y Y scAAV full 1 -m64011_220616_211638/140050829/ccs 2475 Y N ssAAV full 2 -m64011_220616_211638/140117211/ccs/rev 2451 Y N ssAAV full 1 -m64011_220616_211638/140183684/ccs/fwd 866 Y Y scAAV right-partial 1 -m64011_220616_211638/140313301/ccs 4732 Y Y scAAV full 1 -m64011_220616_211638/140313872/ccs 1924 Y N ssAAV right-partial 2 -m64011_220616_211638/140314873/ccs 2906 Y N ssAAV right-partial 2 -m64011_220616_211638/140379139/ccs/rev 4720 Y Y scAAV full 1 -m64011_220616_211638/140380163/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/140509866/ccs/fwd 2913 Y Y scAAV left-partial 1 -m64011_220616_211638/140575019/ccs/rev 4270 Y Y scAAV left-partial 1 -m64011_220616_211638/140641293/ccs/fwd 2414 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/140706213/ccs 2496 Y N ssAAV full 2 -m64011_220616_211638/140707133/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/140771776/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/140773248/ccs 2316 Y N ssAAV full 2 -m64011_220616_211638/140773478/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/140838149/ccs 2446 Y N ssAAV right-partial 2 -m64011_220616_211638/140902866/ccs/rev 3435 Y Y scAAV right-partial 1 -m64011_220616_211638/140904523/ccs/rev 4282 Y Y scAAV right-partial 1 -m64011_220616_211638/140905080/ccs 6766 Y Y scAAV full 1 -m64011_220616_211638/140968262/ccs 2519 Y N ssAAV full 2 -m64011_220616_211638/140968928/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/140970510/ccs 1993 Y N ssAAV left-partial 2 -m64011_220616_211638/141101761/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/141230211/ccs/fwd 2203 Y N ssAAV right-partial 1 -m64011_220616_211638/141230489/ccs 3439 Y Y scAAV right-partial 1 -m64011_220616_211638/141296856/ccs/rev 795 Y Y scAAV left-partial 1 -m64011_220616_211638/141361505/ccs/fwd 2469 Y N ssAAV full 1 -m64011_220616_211638/141363887/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/141428491/ccs 2078 Y N ssAAV right-partial 2 -m64011_220616_211638/141428766/ccs/fwd 4345 Y Y scAAV left-partial 1 -m64011_220616_211638/141558309/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/141558605/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/141560628/ccs/fwd 3000 Y Y scAAV partial 1 -m64011_220616_211638/141625050/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/141691715/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/141757269/ccs 5048 Y Y scAAV full 1 -m64011_220616_211638/141821511/ccs 3172 Y Y scAAV right-partial 1 -m64011_220616_211638/142017573/ccs 3612 Y Y scAAV full|left-partial 1 -m64011_220616_211638/142083779/ccs 4803 Y Y scAAV full 1 -m64011_220616_211638/142084199/ccs 2436 Y N ssAAV full 2 -m64011_220616_211638/142084667/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/142148952/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/142213452/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/142279495/ccs/fwd 4675 Y Y scAAV full 1 -m64011_220616_211638/142280886/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/142344938/ccs/rev 4749 Y Y scAAV full 1 -m64011_220616_211638/142345450/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/142345856/ccs 2466 Y N ssAAV full 2 -m64011_220616_211638/142347044/ccs/rev 4771 Y Y scAAV full 1 -m64011_220616_211638/142475694/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/142475843/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/142477756/ccs/fwd 1376 Y Y scAAV right-partial 1 -m64011_220616_211638/142541447/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/142541712/ccs 3136 Y Y scAAV left-partial 1 -m64011_220616_211638/142608183/ccs 2407 Y N ssAAV full 2 -m64011_220616_211638/142608304/ccs 4758 Y Y scAAV full 1 -m64011_220616_211638/142674365/ccs/rev 4773 Y Y scAAV full 1 -m64011_220616_211638/142738960/ccs/rev 2631 Y N ssAAV right-partial 1 -m64011_220616_211638/142869797/ccs 2480 Y N ssAAV full 2 -m64011_220616_211638/142870368/ccs 1490 Y Y scAAV right-partial 1 -m64011_220616_211638/142934961/ccs 1288 Y Y scAAV right-partial 1 -m64011_220616_211638/142934962/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/142935436/ccs/fwd 4777 Y Y scAAV full 1 -m64011_220616_211638/143066448/ccs/rev 4727 Y Y scAAV full|left-partial 1 -m64011_220616_211638/143066562/ccs 1731 Y Y repcap NA 1 -m64011_220616_211638/143133192/ccs/fwd 4679 Y Y scAAV full 1 -m64011_220616_211638/143133418/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/143198098/ccs 1473 Y Y scAAV left-partial 1 -m64011_220616_211638/143198427/ccs/rev 1599 Y Y scAAV left-partial 1 -m64011_220616_211638/143198891/ccs 925 Y N ssAAV partial 2 -m64011_220616_211638/143264517/ccs 2383 Y N ssAAV full 2 -m64011_220616_211638/143330016/ccs 4753 Y Y scAAV full 1 -m64011_220616_211638/143393851/ccs/fwd 4807 Y Y scAAV full 1 -m64011_220616_211638/143394857/ccs 2194 Y Y repcap NA 1 -m64011_220616_211638/143459100/ccs 4935 Y Y scAAV full 1 -m64011_220616_211638/143459346/ccs 2441 Y N ssAAV full 2 -m64011_220616_211638/143460947/ccs/rev 1920 Y N ssAAV right-partial 1 -m64011_220616_211638/143461118/ccs 2620 Y N ssAAV right-partial 2 -m64011_220616_211638/143589898/ccs 2731 Y Y scAAV right-partial 1 -m64011_220616_211638/143591024/ccs/fwd 4808 Y Y scAAV full 1 -m64011_220616_211638/143591707/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/143655664/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/143655978/ccs/fwd 3042 Y Y scAAV right-partial 1 -m64011_220616_211638/143720616/ccs/rev 4717 Y Y scAAV full 1 -m64011_220616_211638/143722806/ccs/rev 4650 Y Y scAAV full 1 -m64011_220616_211638/143787537/ccs 1741 Y Y scAAV left-partial 1 -m64011_220616_211638/143787658/ccs/rev 756 Y Y scAAV right-partial 1 -m64011_220616_211638/143851858/ccs 8023 Y Y repcap NA 1 -m64011_220616_211638/143853570/ccs/fwd 3437 Y Y scAAV right-partial 1 -m64011_220616_211638/143983557/ccs/fwd 4773 Y Y scAAV full 1 -m64011_220616_211638/144049499/ccs/fwd 4735 N N NA NA 1 -m64011_220616_211638/144049754/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/144114862/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/144313182/ccs 4795 Y Y scAAV full 1 -m64011_220616_211638/144376146/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/144376343/ccs 4773 Y Y scAAV full 1 -m64011_220616_211638/144376730/ccs 2785 Y N ssAAV left-partial 2 -m64011_220616_211638/144378292/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/144442108/ccs 2346 Y N ssAAV right-partial 2 -m64011_220616_211638/144443037/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/144507274/ccs/rev 1767 Y N ssAAV left-partial 1 -m64011_220616_211638/144508000/ccs 3347 Y Y scAAV right-partial 1 -m64011_220616_211638/144508863/ccs/rev 2405 Y N ssAAV full 1 -m64011_220616_211638/144573427/ccs/fwd 4568 Y Y scAAV backbone 1 -m64011_220616_211638/144574795/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/144575102/ccs/fwd 4969 Y Y scAAV full 1 -m64011_220616_211638/144638690/ccs 2369 Y Y scAAV full|right-partial 1 -m64011_220616_211638/144640321/ccs 2408 Y Y scAAV full|right-partial 1 -m64011_220616_211638/144704442/ccs 3150 Y Y scAAV full|left-partial 1 -m64011_220616_211638/144705791/ccs 4768 Y Y scAAV full 1 -m64011_220616_211638/144769552/ccs/rev 4697 Y Y scAAV full 1 -m64011_220616_211638/144836034/ccs/fwd 2437 Y N ssAAV full 1 -m64011_220616_211638/144901098/ccs 2434 Y Y tandem full|right-partial 1 -m64011_220616_211638/144902331/ccs 2413 Y Y tandem full|right-partial 1 -m64011_220616_211638/145163837/ccs 858 Y Y scAAV right-partial 1 -m64011_220616_211638/145228839/ccs 2380 Y Y tandem full|right-partial 1 -m64011_220616_211638/145229448/ccs 3266 Y Y scAAV right-partial 1 -m64011_220616_211638/145295037/ccs/fwd 4705 Y Y scAAV full 1 -m64011_220616_211638/145359957/ccs/rev 2744 Y Y scAAV partial 1 -m64011_220616_211638/145424500/ccs 2494 Y N ssAAV full 2 -m64011_220616_211638/145424538/ccs 4800 Y Y scAAV full 1 -m64011_220616_211638/145425491/ccs/fwd 3574 Y Y scAAV right-partial 1 -m64011_220616_211638/145491128/ccs 2029 Y N ssAAV left-partial 2 -m64011_220616_211638/145557829/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/145557991/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/145621107/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/145622635/ccs/rev 1028 Y N ssAAV left-partial 1 -m64011_220616_211638/145753243/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/145753408/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/145818015/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/145819097/ccs 4773 Y Y scAAV full 1 -m64011_220616_211638/145819909/ccs 2516 Y N ssAAV full 2 -m64011_220616_211638/145949747/ccs/fwd 4777 Y Y scAAV full 1 -m64011_220616_211638/146080155/ccs 2416 Y N ssAAV full 2 -m64011_220616_211638/146080799/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/146212995/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/146277227/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/146277637/ccs/rev 4786 Y Y scAAV full 1 -m64011_220616_211638/146278420/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/146342266/ccs/fwd 4778 Y Y scAAV full 1 -m64011_220616_211638/146342863/ccs 2468 Y N ssAAV full 2 -m64011_220616_211638/146344575/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/146409587/ccs 2357 Y N ssAAV full 2 -m64011_220616_211638/146410008/ccs 4762 Y Y scAAV full 1 -m64011_220616_211638/146604457/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/146606313/ccs 2910 Y Y scAAV right-partial 1 -m64011_220616_211638/146669707/ccs 2004 Y N ssAAV right-partial 2 -m64011_220616_211638/146670439/ccs 3437 Y Y scAAV right-partial 1 -m64011_220616_211638/146736397/ccs 4715 Y Y scAAV full 1 -m64011_220616_211638/146737424/ccs/rev 4776 Y Y scAAV full 1 -m64011_220616_211638/146737463/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/146737698/ccs 2617 Y N ssAAV right-partial 2 -m64011_220616_211638/146802114/ccs/rev 2306 Y N ssAAV right-partial 1 -m64011_220616_211638/146802721/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/146867600/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/146868068/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/146999434/ccs 618 Y Y scAAV right-partial 1 -m64011_220616_211638/147065381/ccs 1055 Y Y scAAV left-partial 1 -m64011_220616_211638/147065443/ccs 5464 Y Y repcap NA 1 -m64011_220616_211638/147129728/ccs/fwd 1548 Y Y scAAV vector+backbone 1 -m64011_220616_211638/147196473/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/147261303/ccs 4803 Y Y scAAV full 1 -m64011_220616_211638/147325929/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/147391471/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/147392499/ccs/fwd 2452 Y N ssAAV full 1 -m64011_220616_211638/147392938/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/147458030/ccs/fwd 4700 Y Y scAAV full 1 -m64011_220616_211638/147522505/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/147524442/ccs/fwd 4355 Y Y scAAV right-partial 1 -m64011_220616_211638/147588586/ccs 4988 Y Y scAAV full 1 -m64011_220616_211638/147654331/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/147654885/ccs/rev 4251 Y Y scAAV vector+backbone 1 -m64011_220616_211638/147719936/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/147721044/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/147850592/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/147915802/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/147916470/ccs/rev 3298 Y Y scAAV right-partial 1 -m64011_220616_211638/148046668/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/148046764/ccs/fwd 2672 Y Y helper NA 1 -m64011_220616_211638/148048213/ccs/fwd 3273 Y Y scAAV left-partial 1 -m64011_220616_211638/148112016/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/148112934/ccs/rev 4782 Y Y scAAV full 1 -m64011_220616_211638/148308604/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/148309838/ccs/fwd 4780 Y Y scAAV full 1 -m64011_220616_211638/148374625/ccs 4766 Y Y scAAV full 1 -m64011_220616_211638/148374817/ccs 1241 Y Y scAAV right-partial 1 -m64011_220616_211638/148375936/ccs 2428 Y N ssAAV full 2 -m64011_220616_211638/148571395/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/148703423/ccs 4032 Y Y scAAV right-partial 1 -m64011_220616_211638/148898647/ccs/rev 4701 Y Y scAAV full 1 -m64011_220616_211638/148900183/ccs/fwd 4788 Y Y scAAV full 1 -m64011_220616_211638/149094817/ccs 2483 Y N ssAAV full 2 -m64011_220616_211638/149095883/ccs 4767 Y Y scAAV full 1 -m64011_220616_211638/149162209/ccs/fwd 2428 Y N ssAAV full 1 -m64011_220616_211638/149228133/ccs/fwd 1823 Y N ssAAV left-partial 1 -m64011_220616_211638/149291589/ccs/fwd 4785 Y Y scAAV full 1 -m64011_220616_211638/149293273/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/149423774/ccs 2442 Y N ssAAV full 2 -m64011_220616_211638/149489586/ccs 2908 Y Y scAAV right-partial 1 -m64011_220616_211638/149489746/ccs/fwd 1832 Y N ssAAV left-partial 1 -m64011_220616_211638/149490103/ccs 958 Y N ssAAV right-partial 2 -m64011_220616_211638/149553601/ccs 3064 Y N repcap NA 1 -m64011_220616_211638/149553846/ccs 4846 Y Y scAAV full 1 -m64011_220616_211638/149554128/ccs/fwd 4074 Y Y scAAV right-partial 1 -m64011_220616_211638/149555227/ccs/rev 4785 Y Y scAAV full 1 -m64011_220616_211638/149619780/ccs/rev 2281 Y N ssAAV right-partial 1 -m64011_220616_211638/149620400/ccs/rev 1018 Y Y scAAV right-partial 1 -m64011_220616_211638/149620587/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/149751449/ccs 2943 Y Y scAAV left-partial 1 -m64011_220616_211638/149816264/ccs 2365 Y N ssAAV full 2 -m64011_220616_211638/149817234/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/149817454/ccs 4426 Y Y scAAV right-partial 1 -m64011_220616_211638/149882492/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/149882525/ccs/rev 2906 Y Y scAAV right-partial 1 -m64011_220616_211638/149946927/ccs/fwd 3180 Y Y scAAV right-partial 1 -m64011_220616_211638/149947350/ccs/rev 4929 Y Y scAAV full 1 -m64011_220616_211638/149948503/ccs 4731 Y Y scAAV full 1 -m64011_220616_211638/150013154/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/150013778/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/150078779/ccs/fwd 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/150210944/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/150274401/ccs/fwd 4335 Y Y scAAV right-partial 1 -m64011_220616_211638/150274650/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/150275201/ccs 2027 Y N ssAAV left-partial 2 -m64011_220616_211638/150275884/ccs/fwd 3133 Y Y scAAV right-partial 1 -m64011_220616_211638/150276609/ccs/fwd 2439 Y N ssAAV full 1 -m64011_220616_211638/150340754/ccs 2443 Y N ssAAV full 2 -m64011_220616_211638/150341941/ccs/fwd 2909 Y Y scAAV right-partial 1 -m64011_220616_211638/150405733/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/150407941/ccs/rev 2452 Y N ssAAV full 1 -m64011_220616_211638/150471233/ccs 1844 Y Y scAAV right-partial 1 -m64011_220616_211638/150473209/ccs/rev 3797 Y Y scAAV full|left-partial 1 -m64011_220616_211638/150538253/ccs/fwd 4673 Y Y scAAV full 1 -m64011_220616_211638/150669046/ccs/fwd 4720 Y Y scAAV full 1 -m64011_220616_211638/150734582/ccs 494 Y Y scAAV right-partial 1 -m64011_220616_211638/150866220/ccs 2408 Y N ssAAV full 2 -m64011_220616_211638/150932147/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/150995664/ccs/fwd 1504 Y N ssAAV right-partial 1 -m64011_220616_211638/151061331/ccs/rev 2454 Y N ssAAV full 1 -m64011_220616_211638/151061678/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/151126740/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/151126912/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/151127447/ccs/rev 2454 Y N ssAAV full 1 -m64011_220616_211638/151127929/ccs/fwd 3534 Y Y scAAV right-partial 1 -m64011_220616_211638/151191837/ccs 3070 Y Y scAAV right-partial 1 -m64011_220616_211638/151258093/ccs 4699 Y Y scAAV full 1 -m64011_220616_211638/151323588/ccs 4778 Y Y scAAV full 1 -m64011_220616_211638/151324197/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/151324664/ccs 1330 Y N ssAAV left-partial 2 -m64011_220616_211638/151324771/ccs 4698 Y Y scAAV full 1 -m64011_220616_211638/151390467/ccs 4744 Y Y scAAV full 1 -m64011_220616_211638/151520146/ccs/rev 4774 Y Y scAAV full 1 -m64011_220616_211638/151584927/ccs 4775 Y Y scAAV full 1 -m64011_220616_211638/151585518/ccs/rev 7878 Y Y helper NA 1 -m64011_220616_211638/151651263/ccs/rev 1686 Y N ssAAV left-partial 1 -m64011_220616_211638/151783132/ccs/rev 3307 Y Y scAAV right-partial 1 -m64011_220616_211638/151783479/ccs/fwd 3377 Y N unclassified right-partial 1 -m64011_220616_211638/151915103/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/151978527/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/152045025/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/152110952/ccs/rev 4680 Y Y scAAV full 1 -m64011_220616_211638/152175025/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/152175719/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/152241866/ccs 1101 Y Y scAAV left-partial 1 -m64011_220616_211638/152305927/ccs 1324 Y N ssAAV left-partial 2 -m64011_220616_211638/152307938/ccs/fwd 4938 Y Y scAAV full 1 -m64011_220616_211638/152372412/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/152437633/ccs/fwd 2125 Y Y scAAV right-partial 1 -m64011_220616_211638/152438584/ccs 1584 Y Y scAAV right-partial 1 -m64011_220616_211638/152502703/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/152569166/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/152701603/ccs/fwd 4742 Y Y scAAV full 1 -m64011_220616_211638/152831218/ccs 2366 Y N ssAAV full 2 -m64011_220616_211638/152831716/ccs/fwd 2827 Y N ssAAV right-partial 1 -m64011_220616_211638/152831930/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/152896079/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/152896726/ccs 2423 Y Y scAAV right-partial 1 -m64011_220616_211638/152961738/ccs 2321 Y N ssAAV full 2 -m64011_220616_211638/152962749/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/152963351/ccs/rev 3572 Y Y scAAV right-partial 1 -m64011_220616_211638/153026945/ccs 2622 Y Y scAAV full|right-partial 1 -m64011_220616_211638/153093737/ccs 2611 Y N ssAAV full 2 -m64011_220616_211638/153094270/ccs/fwd 4777 Y Y scAAV full 1 -m64011_220616_211638/153094525/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/153224445/ccs/fwd 4779 Y Y scAAV full 1 -m64011_220616_211638/153225612/ccs/fwd 3875 Y Y scAAV left-partial 1 -m64011_220616_211638/153355428/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/153420733/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/153421632/ccs 4417 Y Y scAAV left-partial 1 -m64011_220616_211638/153421652/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/153486040/ccs 4522 Y Y scAAV full|right-partial 1 -m64011_220616_211638/153487340/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/153487402/ccs 2475 Y N ssAAV full 2 -m64011_220616_211638/153552292/ccs/rev 2415 Y N ssAAV full 1 -m64011_220616_211638/153617743/ccs/fwd 4594 Y Y scAAV full 1 -m64011_220616_211638/153617877/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/153748006/ccs 4466 Y Y scAAV left-partial 1 -m64011_220616_211638/153750048/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/154011957/ccs/fwd 3774 Y Y scAAV right-partial 1 -m64011_220616_211638/154076225/ccs/rev 4004 Y Y scAAV right-partial 1 -m64011_220616_211638/154143238/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/154208710/ccs 1690 Y Y scAAV right-partial 1 -m64011_220616_211638/154403259/ccs 4814 Y Y scAAV full 1 -m64011_220616_211638/154403555/ccs/fwd 4783 Y Y scAAV full 1 -m64011_220616_211638/154404173/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/154534373/ccs/fwd 4785 Y Y scAAV full 1 -m64011_220616_211638/154535286/ccs/fwd 2024 Y Y scAAV left-partial 1 -m64011_220616_211638/154536692/ccs/fwd 4691 Y Y scAAV full 1 -m64011_220616_211638/154599768/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/154600711/ccs 2504 Y N ssAAV full 2 -m64011_220616_211638/154601779/ccs/rev 4775 Y Y scAAV full 1 -m64011_220616_211638/154665295/ccs 4789 Y Y scAAV full 1 -m64011_220616_211638/154667140/ccs/rev 3600 Y Y scAAV left-partial 1 -m64011_220616_211638/154797559/ccs/fwd 4701 Y Y scAAV full 1 -m64011_220616_211638/154862721/ccs/rev 4775 Y Y scAAV full 1 -m64011_220616_211638/154863269/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/154863888/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/154864205/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/154992724/ccs 1320 Y Y tandem backbone|left-partial 1 -m64011_220616_211638/155058870/ccs/rev 4770 Y Y scAAV full 1 -m64011_220616_211638/155059212/ccs/rev 4742 Y Y scAAV full 1 -m64011_220616_211638/155191469/ccs 4718 Y Y scAAV full 1 -m64011_220616_211638/155388745/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/155517845/ccs 3574 Y Y scAAV right-partial 1 -m64011_220616_211638/155583495/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/155649255/ccs/rev 2413 Y Y scAAV full|right-partial 1 -m64011_220616_211638/155714522/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/155779450/ccs/rev 4679 Y Y scAAV full 1 -m64011_220616_211638/155781541/ccs/fwd 4335 Y Y scAAV left-partial 1 -m64011_220616_211638/155781928/ccs 6317 Y N host NA 1 -m64011_220616_211638/155845981/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/155912714/ccs/rev 4705 Y Y scAAV full 1 -m64011_220616_211638/156173663/ccs/rev 2136 Y Y scAAV right-partial 1 -m64011_220616_211638/156173690/ccs/fwd 4758 Y Y scAAV full 1 -m64011_220616_211638/156239046/ccs 4729 Y Y scAAV full 1 -m64011_220616_211638/156239697/ccs 1738 Y N ssAAV left-partial 2 -m64011_220616_211638/156369079/ccs/fwd 4677 Y Y scAAV full 1 -m64011_220616_211638/156500303/ccs 2295 Y N ssAAV left-partial 2 -m64011_220616_211638/156567161/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/156632583/ccs/fwd 4736 Y Y scAAV full 1 -m64011_220616_211638/156698011/ccs 2419 Y Y scAAV full|right-partial 1 -m64011_220616_211638/156698521/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/156895383/ccs 2751 Y Y scAAV right-partial 1 -m64011_220616_211638/156959892/ccs 2128 Y N ssAAV left-partial 2 -m64011_220616_211638/157026532/ccs/fwd 2449 Y N ssAAV full 1 -m64011_220616_211638/157026959/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/157155470/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/157157181/ccs/rev 2234 Y Y scAAV left-partial 1 -m64011_220616_211638/157158184/ccs 2126 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/157222976/ccs/fwd 2331 Y Y scAAV right-partial 1 -m64011_220616_211638/157223688/ccs 765 Y Y scAAV left-partial 1 -m64011_220616_211638/157286784/ccs 2372 Y Y scAAV full|right-partial 1 -m64011_220616_211638/157287270/ccs 4784 Y Y scAAV full 1 -m64011_220616_211638/157287593/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/157354289/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/157483687/ccs 2463 Y N ssAAV full 2 -m64011_220616_211638/157549204/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/157549677/ccs 1640 Y Y scAAV left-partial|right-partial 1 -m64011_220616_211638/157549791/ccs 3878 Y Y scAAV left-partial 1 -m64011_220616_211638/157614306/ccs/fwd 3138 Y Y scAAV partial 1 -m64011_220616_211638/157615120/ccs 2578 Y N ssAAV full 2 -m64011_220616_211638/157615503/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/157680872/ccs/fwd 4719 Y Y scAAV full 1 -m64011_220616_211638/157682029/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/157745382/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/157813238/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/157878646/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/158271861/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/158335171/ccs 2384 Y N ssAAV full 2 -m64011_220616_211638/158336052/ccs 4198 Y N unclassified right-partial 1 -m64011_220616_211638/158336647/ccs 2645 Y N ssAAV full 2 -m64011_220616_211638/158402147/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/158403069/ccs 2392 Y N ssAAV full 2 -m64011_220616_211638/158597646/ccs 2576 Y N ssAAV full 2 -m64011_220616_211638/158599799/ccs 923 Y Y scAAV right-partial 1 -m64011_220616_211638/158664504/ccs 4755 Y Y scAAV full 1 -m64011_220616_211638/158665313/ccs 2404 Y N ssAAV full 2 -m64011_220616_211638/158795836/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/158927192/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/158991410/ccs 2101 Y N ssAAV right-partial 2 -m64011_220616_211638/159122400/ccs/rev 1682 Y N ssAAV right-partial 1 -m64011_220616_211638/159187592/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/159187809/ccs 624 Y N ssAAV partial 2 -m64011_220616_211638/159188097/ccs 2597 Y Y scAAV right-partial 1 -m64011_220616_211638/159384307/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/159386196/ccs/fwd 4763 Y Y scAAV full 1 -m64011_220616_211638/159582818/ccs 2830 Y N ssAAV right-partial 2 -m64011_220616_211638/159646694/ccs 2459 Y N ssAAV full 2 -m64011_220616_211638/159646739/ccs/rev 4774 Y Y scAAV full 1 -m64011_220616_211638/159647001/ccs 5784 Y Y host NA 1 -m64011_220616_211638/159647739/ccs 2402 Y N ssAAV full 2 -m64011_220616_211638/159648505/ccs 2397 Y N ssAAV full 2 -m64011_220616_211638/159711936/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/159777541/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/159779574/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/159843293/ccs/fwd 1383 Y Y scAAV right-partial 1 -m64011_220616_211638/159844342/ccs 2336 Y N ssAAV full 2 -m64011_220616_211638/159844550/ccs/fwd 1859 Y N ssAAV right-partial 1 -m64011_220616_211638/159908351/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/159910274/ccs 2465 Y N ssAAV full 2 -m64011_220616_211638/160041020/ccs/fwd 4407 Y Y scAAV right-partial 1 -m64011_220616_211638/160105074/ccs/fwd 2431 Y N ssAAV full 1 -m64011_220616_211638/160105119/ccs/rev 3080 Y Y scAAV right-partial 1 -m64011_220616_211638/160170973/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/160171032/ccs 1496 Y N ssAAV left-partial 2 -m64011_220616_211638/160171984/ccs 2412 Y Y scAAV full|right-partial 1 -m64011_220616_211638/160237704/ccs 2381 Y Y scAAV full|right-partial 1 -m64011_220616_211638/160237709/ccs 999 Y N unclassified right-partial 1 -m64011_220616_211638/160301859/ccs 4698 Y Y scAAV full 1 -m64011_220616_211638/160367802/ccs/fwd 2233 Y N ssAAV left-partial 1 -m64011_220616_211638/160498417/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/160498654/ccs 4053 Y Y scAAV left-partial 1 -m64011_220616_211638/160499378/ccs/rev 1379 Y Y scAAV right-partial 1 -m64011_220616_211638/160760312/ccs 1697 Y N ssAAV right-partial 2 -m64011_220616_211638/160761299/ccs/rev 4668 N N NA NA 1 -m64011_220616_211638/161022131/ccs/rev 1854 Y Y scAAV right-partial 1 -m64011_220616_211638/161023165/ccs/fwd 4778 Y Y scAAV full 1 -m64011_220616_211638/161023935/ccs 3481 Y Y scAAV right-partial 1 -m64011_220616_211638/161087907/ccs/rev 1153 Y Y scAAV left-partial 1 -m64011_220616_211638/161219710/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/161285627/ccs 3949 N N NA NA 1 -m64011_220616_211638/161352384/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/161483070/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/161546620/ccs 2518 Y N ssAAV full 2 -m64011_220616_211638/161612220/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/161614350/ccs 2789 Y Y scAAV partial 1 -m64011_220616_211638/161680091/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/161876113/ccs 2447 Y N ssAAV full 2 -m64011_220616_211638/162007508/ccs 6947 Y Y scAAV full 1 -m64011_220616_211638/162071830/ccs 4729 Y Y scAAV full 1 -m64011_220616_211638/162138962/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/162202749/ccs 6275 Y N host NA 1 -m64011_220616_211638/162269935/ccs 2209 Y N ssAAV right-partial 2 -m64011_220616_211638/162335086/ccs 2199 Y Y scAAV right-partial 1 -m64011_220616_211638/162399084/ccs/rev 1322 Y Y scAAV right-partial 1 -m64011_220616_211638/162529493/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/162529557/ccs/rev 4699 Y Y scAAV full 1 -m64011_220616_211638/162595328/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/162597149/ccs/rev 4854 Y Y scAAV full 1 -m64011_220616_211638/162792186/ccs/fwd 1532 Y Y scAAV right-partial 1 -m64011_220616_211638/162858303/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/162858304/ccs/rev 4808 Y Y scAAV full 1 -m64011_220616_211638/162923652/ccs/rev 2335 Y Y tandem left-partial|right-partial 1 -m64011_220616_211638/162923861/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/163054289/ccs 4453 Y Y scAAV left-partial 1 -m64011_220616_211638/163121939/ccs/rev 2318 Y N ssAAV right-partial 1 -m64011_220616_211638/163187194/ccs 3102 Y Y scAAV right-partial 1 -m64011_220616_211638/163187367/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/163316762/ccs/fwd 4771 Y Y scAAV full 1 -m64011_220616_211638/163318288/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/163318293/ccs/fwd 2577 Y Y scAAV right-partial 1 -m64011_220616_211638/163447322/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/163449575/ccs/rev 3731 Y Y scAAV right-partial 1 -m64011_220616_211638/163512880/ccs 2371 Y N ssAAV full 2 -m64011_220616_211638/163513289/ccs 4002 Y Y scAAV left-partial 1 -m64011_220616_211638/163579508/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/163579842/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/163709959/ccs/fwd 2287 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/163841090/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/163907013/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/163971787/ccs/fwd 4701 Y Y scAAV full 1 -m64011_220616_211638/164103953/ccs/fwd 2823 Y Y scAAV right-partial 1 -m64011_220616_211638/164103986/ccs/rev 2389 Y Y scAAV backbone|right-partial 1 -m64011_220616_211638/164104039/ccs/rev 4763 Y Y scAAV full 1 -m64011_220616_211638/164104738/ccs/fwd 4715 Y Y scAAV full 1 -m64011_220616_211638/164233438/ccs/fwd 2826 Y Y scAAV left-partial 1 -m64011_220616_211638/164234643/ccs 1197 Y N ssAAV right-partial 2 -m64011_220616_211638/164301592/ccs 2390 Y N ssAAV full 2 -m64011_220616_211638/164496154/ccs 4780 Y Y scAAV full 1 -m64011_220616_211638/164496928/ccs/rev 2158 Y Y tandem partial 1 -m64011_220616_211638/164497057/ccs/rev 1387 Y Y scAAV left-partial 1 -m64011_220616_211638/164563037/ccs/rev 4031 Y Y scAAV right-partial 1 -m64011_220616_211638/164627173/ccs 2461 Y N ssAAV full 2 -m64011_220616_211638/164692257/ccs 2463 Y N ssAAV full 2 -m64011_220616_211638/164692972/ccs 2472 Y N ssAAV full 2 -m64011_220616_211638/164693144/ccs 2107 Y N ssAAV right-partial 2 -m64011_220616_211638/164694584/ccs/rev 4780 Y Y scAAV full 1 -m64011_220616_211638/164759829/ccs/fwd 4785 Y Y scAAV full 1 -m64011_220616_211638/164824051/ccs 4773 Y Y scAAV full 1 -m64011_220616_211638/164824580/ccs 2472 Y N ssAAV full 2 -m64011_220616_211638/164825059/ccs/rev 2879 Y Y scAAV right-partial 1 -m64011_220616_211638/164825656/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/164955532/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/164956844/ccs 943 Y N unclassified right-partial 1 -m64011_220616_211638/165020296/ccs 2032 Y N ssAAV left-partial 2 -m64011_220616_211638/165021204/ccs 3438 Y Y scAAV right-partial 1 -m64011_220616_211638/165087521/ccs/fwd 4780 Y Y scAAV full 1 -m64011_220616_211638/165152378/ccs 526 Y Y scAAV right-partial 1 -m64011_220616_211638/165348010/ccs/rev 4789 Y Y scAAV full 1 -m64011_220616_211638/165413995/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/165415057/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/165544054/ccs 4075 Y Y scAAV right-partial 1 -m64011_220616_211638/165545912/ccs 2372 Y Y scAAV full|right-partial 1 -m64011_220616_211638/165546142/ccs 2411 Y Y scAAV full|right-partial 1 -m64011_220616_211638/165675902/ccs 3979 Y Y repcap NA 1 -m64011_220616_211638/165807847/ccs 2470 Y N ssAAV full 2 -m64011_220616_211638/165808233/ccs 3091 Y Y scAAV left-partial 1 -m64011_220616_211638/165873889/ccs/rev 2695 Y Y scAAV full|right-partial 1 -m64011_220616_211638/166070248/ccs/fwd 4702 Y Y scAAV full 1 -m64011_220616_211638/166070745/ccs 4700 Y Y scAAV full 1 -m64011_220616_211638/166200505/ccs/fwd 2216 Y N ssAAV right-partial 1 -m64011_220616_211638/166200586/ccs 4783 Y Y scAAV full 1 -m64011_220616_211638/166265243/ccs 2904 Y N ssAAV right-partial 2 -m64011_220616_211638/166266017/ccs 3006 Y Y scAAV partial 1 -m64011_220616_211638/166333186/ccs 2725 Y N ssAAV full 2 -m64011_220616_211638/166527194/ccs 1165 Y N ssAAV right-partial 2 -m64011_220616_211638/166593371/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/166593509/ccs/rev 4703 Y Y scAAV full 1 -m64011_220616_211638/166594825/ccs 2411 Y Y tandem full|right-partial 1 -m64011_220616_211638/166658836/ccs 3571 Y Y scAAV full|right-partial 1 -m64011_220616_211638/166724972/ccs 4702 Y Y scAAV full 1 -m64011_220616_211638/166725402/ccs 2420 Y N ssAAV full 2 -m64011_220616_211638/166725769/ccs 2223 Y N ssAAV right-partial 2 -m64011_220616_211638/166725836/ccs/fwd 1584 Y N ssAAV left-partial 1 -m64011_220616_211638/166790190/ccs/rev 4528 Y Y repcap NA 1 -m64011_220616_211638/166856820/ccs 2444 Y N ssAAV full 2 -m64011_220616_211638/166920403/ccs 4816 Y Y scAAV full 1 -m64011_220616_211638/167051773/ccs 2137 Y N ssAAV vector+backbone 2 -m64011_220616_211638/167116945/ccs 1527 Y N ssAAV right-partial 2 -m64011_220616_211638/167119529/ccs 2618 Y Y tandem full|left-partial 1 -m64011_220616_211638/167447391/ccs 4940 Y Y scAAV full 1 -m64011_220616_211638/167576580/ccs/rev 1378 Y Y scAAV right-partial 1 -m64011_220616_211638/167578220/ccs/fwd 2409 Y Y tandem full|right-partial 1 -m64011_220616_211638/167709425/ccs 4771 Y Y scAAV full 1 -m64011_220616_211638/167772528/ccs/fwd 3439 Y Y scAAV right-partial 1 -m64011_220616_211638/167839114/ccs 2208 Y N ssAAV right-partial 2 -m64011_220616_211638/167839550/ccs/fwd 4691 Y Y scAAV full 1 -m64011_220616_211638/167903919/ccs 2359 Y N ssAAV full 2 -m64011_220616_211638/167904664/ccs 2661 Y N ssAAV right-partial 2 -m64011_220616_211638/168035926/ccs/fwd 4781 Y Y scAAV full 1 -m64011_220616_211638/168036191/ccs 3506 Y Y scAAV right-partial 1 -m64011_220616_211638/168036270/ccs/fwd 3421 Y Y scAAV right-partial 1 -m64011_220616_211638/168166381/ccs 2398 Y N ssAAV full 2 -m64011_220616_211638/168167128/ccs 2617 Y Y scAAV full|left-partial 1 -m64011_220616_211638/168167184/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/168167804/ccs/fwd 844 Y Y scAAV left-partial 1 -m64011_220616_211638/168232614/ccs 835 Y Y scAAV right-partial 1 -m64011_220616_211638/168233594/ccs/rev 3616 Y Y scAAV right-partial 1 -m64011_220616_211638/168296697/ccs 4406 Y Y scAAV right-partial 1 -m64011_220616_211638/168297666/ccs 3827 Y Y scAAV left-partial 1 -m64011_220616_211638/168297866/ccs 2268 Y Y scAAV left-partial 1 -m64011_220616_211638/168362198/ccs 2372 Y Y scAAV full|right-partial 1 -m64011_220616_211638/168362614/ccs 2412 Y N ssAAV full 2 -m64011_220616_211638/168559275/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/168626666/ccs/rev 3006 Y Y scAAV left-partial 1 -m64011_220616_211638/168755594/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/168755701/ccs 3413 Y Y scAAV right-partial 1 -m64011_220616_211638/168757209/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/168821722/ccs/fwd 2325 Y Y tandem vector+backbone 1 -m64011_220616_211638/168887979/ccs 2410 Y N ssAAV full 2 -m64011_220616_211638/168888784/ccs 2371 Y Y scAAV full|right-partial 1 -m64011_220616_211638/168954334/ccs/fwd 3312 Y Y scAAV right-partial 1 -m64011_220616_211638/169017918/ccs 2370 Y Y scAAV full|right-partial 1 -m64011_220616_211638/169084018/ccs 971 Y N unclassified left-partial 1 -m64011_220616_211638/169214354/ccs 2651 Y Y repcap|vector NA|left-partial 1 -m64011_220616_211638/169281702/ccs/rev 4698 Y Y scAAV full 1 -m64011_220616_211638/169281993/ccs 1945 Y N ssAAV right-partial 2 -m64011_220616_211638/169282053/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/169345965/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/169476649/ccs 4777 Y Y scAAV full 1 -m64011_220616_211638/169477232/ccs 4701 Y Y scAAV full 1 -m64011_220616_211638/169542880/ccs/rev 3224 Y Y scAAV right-partial 1 -m64011_220616_211638/169543289/ccs 2031 Y N ssAAV right-partial 2 -m64011_220616_211638/169544229/ccs 1380 Y Y scAAV right-partial 1 -m64011_220616_211638/169675378/ccs 2439 Y N ssAAV full 2 -m64011_220616_211638/169740207/ccs 4870 Y Y scAAV full 1 -m64011_220616_211638/169805037/ccs 2480 Y N ssAAV full 2 -m64011_220616_211638/169805057/ccs 2071 Y N ssAAV left-partial 2 -m64011_220616_211638/169936479/ccs 4761 Y Y scAAV full 1 -m64011_220616_211638/170001690/ccs/fwd 2382 Y Y scAAV full|right-partial 1 -m64011_220616_211638/170133496/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/170199373/ccs 2451 Y N ssAAV full 2 -m64011_220616_211638/170263676/ccs/fwd 1528 Y Y scAAV right-partial 1 -m64011_220616_211638/170328469/ccs 2337 Y N repcap NA 1 -m64011_220616_211638/170396345/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/170461041/ccs 2464 Y N ssAAV full 2 -m64011_220616_211638/170461934/ccs 4908 Y Y scAAV full 1 -m64011_220616_211638/170526570/ccs 3857 Y Y repcap NA 1 -m64011_220616_211638/170527328/ccs/fwd 4719 Y Y scAAV full 1 -m64011_220616_211638/170592364/ccs 4779 Y Y scAAV full 1 -m64011_220616_211638/170786922/ccs 4780 Y Y scAAV backbone 1 -m64011_220616_211638/170788410/ccs 4742 Y Y scAAV full 1 -m64011_220616_211638/170853208/ccs 4782 Y Y scAAV full 1 -m64011_220616_211638/170854026/ccs/rev 2483 Y N ssAAV full 1 -m64011_220616_211638/170854568/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/170918948/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/170919192/ccs/rev 3125 Y Y scAAV right-partial|left-partial 1 -m64011_220616_211638/170986323/ccs/fwd 4894 Y Y scAAV full 1 -m64011_220616_211638/171050336/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/171051744/ccs/rev 3884 Y Y scAAV right-partial 1 -m64011_220616_211638/171115313/ccs/rev 4787 Y Y scAAV full 1 -m64011_220616_211638/171245797/ccs/fwd 1269 Y Y scAAV right-partial 1 -m64011_220616_211638/171313653/ccs/fwd 2204 Y N ssAAV right-partial 1 -m64011_220616_211638/171442317/ccs/fwd 3912 Y Y scAAV right-partial 1 -m64011_220616_211638/171442962/ccs 4420 Y Y scAAV left-partial 1 -m64011_220616_211638/171508457/ccs 2412 Y Y tandem full|right-partial 1 -m64011_220616_211638/171508702/ccs 487 Y N ssAAV right-partial 2 -m64011_220616_211638/171509674/ccs/fwd 4555 Y Y scAAV left-partial 1 -m64011_220616_211638/171574645/ccs 2470 Y N ssAAV full 2 -m64011_220616_211638/171639780/ccs 2204 Y N ssAAV right-partial 2 -m64011_220616_211638/171640149/ccs 3008 Y Y scAAV right-partial 1 -m64011_220616_211638/171640837/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/171771045/ccs/rev 2911 Y Y scAAV right-partial 1 -m64011_220616_211638/171771797/ccs 2451 Y Y tandem full|right-partial 1 -m64011_220616_211638/171837845/ccs 3160 Y Y repcap NA 1 -m64011_220616_211638/171902407/ccs 1570 Y N ssAAV left-partial 2 -m64011_220616_211638/171902696/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/171903299/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/171903824/ccs 2047 Y N ssAAV right-partial 2 -m64011_220616_211638/171968327/ccs/rev 4769 Y Y scAAV full 1 -m64011_220616_211638/172034364/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/172163186/ccs 2204 Y N ssAAV right-partial 2 -m64011_220616_211638/172163386/ccs 2419 Y Y scAAV full|right-partial 1 -m64011_220616_211638/172163671/ccs 2250 Y N ssAAV left-partial 2 -m64011_220616_211638/172295601/ccs 4802 Y Y scAAV full 1 -m64011_220616_211638/172295754/ccs/rev 2410 Y N ssAAV full 1 -m64011_220616_211638/172361231/ccs 4761 Y Y scAAV full 1 -m64011_220616_211638/172362145/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/172491795/ccs/rev 4767 Y Y scAAV full 1 -m64011_220616_211638/172559058/ccs 2476 Y N ssAAV full 2 -m64011_220616_211638/172622287/ccs/rev 2413 Y N ssAAV full 1 -m64011_220616_211638/172623750/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/172821021/ccs/fwd 4772 Y Y scAAV full 1 -m64011_220616_211638/172950883/ccs 2410 Y N ssAAV full 2 -m64011_220616_211638/172951736/ccs/fwd 4573 Y Y scAAV full 1 -m64011_220616_211638/173017709/ccs 2511 Y Y tandem full|left-partial 1 -m64011_220616_211638/173081705/ccs 4267 Y Y scAAV right-partial 1 -m64011_220616_211638/173082844/ccs 1908 Y N ssAAV left-partial 2 -m64011_220616_211638/173146584/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/173212038/ccs 2211 Y N ssAAV right-partial 2 -m64011_220616_211638/173212818/ccs 4785 Y Y scAAV full 1 -m64011_220616_211638/173277229/ccs 2457 Y N ssAAV full 2 -m64011_220616_211638/173278713/ccs 2465 Y N ssAAV full 2 -m64011_220616_211638/173279626/ccs 2432 Y N ssAAV full 2 -m64011_220616_211638/173409307/ccs 2440 Y Y scAAV full|right-partial 1 -m64011_220616_211638/173409763/ccs 2471 Y N ssAAV full 2 -m64011_220616_211638/173409861/ccs/rev 3159 Y Y scAAV right-partial 1 -m64011_220616_211638/173410226/ccs 4167 Y Y scAAV partial 1 -m64011_220616_211638/173474176/ccs 1557 Y N ssAAV left-partial 2 -m64011_220616_211638/173606527/ccs/fwd 2453 Y N ssAAV full 1 -m64011_220616_211638/173671259/ccs 4765 Y Y scAAV full 1 -m64011_220616_211638/173672683/ccs 2416 Y N ssAAV full 2 -m64011_220616_211638/173869421/ccs 2476 Y N ssAAV full 2 -m64011_220616_211638/173934100/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/174000244/ccs 935 Y N ssAAV right-partial 2 -m64011_220616_211638/174064243/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/174064881/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/174131511/ccs/fwd 4784 Y Y scAAV full 1 -m64011_220616_211638/174197135/ccs 4195 Y Y scAAV right-partial 1 -m64011_220616_211638/174261553/ccs/fwd 2811 Y Y scAAV backbone|vector+backbone 1 -m64011_220616_211638/174327841/ccs 5190 Y Y scAAV full 1 -m64011_220616_211638/174328346/ccs/rev 4775 Y Y scAAV full 1 -m64011_220616_211638/174392081/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/174393772/ccs 817 Y N ssAAV right-partial 2 -m64011_220616_211638/174457687/ccs/rev 1961 Y Y scAAV left-partial 1 -m64011_220616_211638/174524477/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/174719837/ccs 2031 Y N ssAAV left-partial 2 -m64011_220616_211638/174720615/ccs/fwd 4782 Y Y scAAV full 1 -m64011_220616_211638/174720953/ccs 3902 Y Y scAAV left-partial 1 -m64011_220616_211638/174850355/ccs/fwd 2444 Y N ssAAV full 1 -m64011_220616_211638/174916287/ccs 2385 Y N ssAAV full 2 -m64011_220616_211638/174917426/ccs 2378 Y N ssAAV full 2 -m64011_220616_211638/175114434/ccs 1984 Y N ssAAV right-partial 2 -m64011_220616_211638/175114488/ccs 2447 Y Y tandem full|right-partial 1 -m64011_220616_211638/175114519/ccs/rev 3448 Y Y scAAV right-partial 1 -m64011_220616_211638/175180294/ccs 4927 Y Y scAAV full 1 -m64011_220616_211638/175310485/ccs 5131 Y Y scAAV full 1 -m64011_220616_211638/175375035/ccs/fwd 2410 Y Y scAAV backbone 1 -m64011_220616_211638/175376086/ccs 2448 Y N ssAAV full 2 -m64011_220616_211638/175506968/ccs 2411 Y Y tandem full|right-partial 1 -m64011_220616_211638/175507300/ccs/rev 990 Y N unclassified vector+backbone 1 -m64011_220616_211638/175508151/ccs/fwd 3315 Y Y scAAV right-partial 1 -m64011_220616_211638/175573010/ccs/fwd 2663 Y Y scAAV full|left-partial 1 -m64011_220616_211638/175573583/ccs 2123 Y Y scAAV right-partial 1 -m64011_220616_211638/175638450/ccs/fwd 2499 Y Y tandem right-partial|left-partial 1 -m64011_220616_211638/175703111/ccs 1674 Y Y vector|helper right-partial|NA 1 -m64011_220616_211638/175703402/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/175704388/ccs 2438 Y N ssAAV full 2 -m64011_220616_211638/175769127/ccs 2644 Y Y tandem backbone|left-partial 1 -m64011_220616_211638/175834701/ccs 3991 Y Y scAAV left-partial 1 -m64011_220616_211638/175966134/ccs/rev 4146 Y Y scAAV left-partial 1 -m64011_220616_211638/175966422/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/176030060/ccs/rev 4764 Y Y scAAV full 1 -m64011_220616_211638/176031787/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/176096862/ccs 1469 Y Y scAAV left-partial 1 -m64011_220616_211638/176097019/ccs 473 Y Y scAAV partial 1 -m64011_220616_211638/176162275/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/176226897/ccs 5848 Y N host NA 1 -m64011_220616_211638/176228045/ccs 2558 Y N ssAAV right-partial 2 -m64011_220616_211638/176228374/ccs 4825 Y Y scAAV full 1 -m64011_220616_211638/176229009/ccs 2453 Y N ssAAV full 2 -m64011_220616_211638/176292939/ccs 2450 Y N ssAAV full 2 -m64011_220616_211638/176360285/ccs 2458 Y N ssAAV full 2 -m64011_220616_211638/176424329/ccs 1656 Y Y scAAV left-partial 1 -m64011_220616_211638/176425304/ccs 2373 Y N ssAAV full 2 -m64011_220616_211638/176752943/ccs 2442 Y N ssAAV full 2 -m64011_220616_211638/176753388/ccs 1676 Y Y scAAV left-partial|right-partial 1 -m64011_220616_211638/176882826/ccs/fwd 3444 Y Y scAAV right-partial 1 -m64011_220616_211638/177079583/ccs/fwd 4704 Y Y scAAV full 1 -m64011_220616_211638/177210608/ccs 1207 Y Y scAAV right-partial 1 -m64011_220616_211638/177276294/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/177277471/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/177277480/ccs/fwd 1440 Y Y scAAV right-partial 1 -m64011_220616_211638/177408231/ccs 1277 Y Y scAAV right-partial 1 -m64011_220616_211638/177537502/ccs 2460 Y N ssAAV full 2 -m64011_220616_211638/177538492/ccs 4409 Y Y scAAV left-partial 1 -m64011_220616_211638/177800012/ccs 4694 Y Y scAAV full 1 -m64011_220616_211638/177800838/ccs 2455 Y N ssAAV full 2 -m64011_220616_211638/177801759/ccs/fwd 4767 Y Y scAAV full 1 -m64011_220616_211638/177866111/ccs 2475 Y N ssAAV full 2 -m64011_220616_211638/177866950/ccs 4467 Y Y scAAV left-partial 1 -m64011_220616_211638/177867199/ccs 4980 Y Y scAAV full 1 -m64011_220616_211638/177998225/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/178062103/ccs/fwd 2176 Y Y scAAV partial 1 -m64011_220616_211638/178127432/ccs/fwd 1713 Y Y scAAV left-partial 1 -m64011_220616_211638/178194969/ccs 2456 Y N ssAAV full 2 -m64011_220616_211638/178259458/ccs 2905 Y Y helper NA 1 -m64011_220616_211638/178390847/ccs/rev 2500 Y Y scAAV right-partial 1 -m64011_220616_211638/178391110/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/178391428/ccs 2467 Y N ssAAV full 2 -m64011_220616_211638/178454786/ccs/fwd 2381 Y N ssAAV full 1 -m64011_220616_211638/178455601/ccs 2446 Y N ssAAV full 2 -m64011_220616_211638/178520957/ccs/fwd 4718 Y Y scAAV full 1 -m64011_220616_211638/178522070/ccs 2047 Y Y repcap NA 1 -m64011_220616_211638/178587744/ccs 597 Y Y scAAV right-partial 1 -m64011_220616_211638/178784119/ccs/fwd 2910 Y N ssAAV right-partial 1 -m64011_220616_211638/178784823/ccs 1294 Y N ssAAV right-partial 2 -m64011_220616_211638/178848335/ccs/rev 4936 Y Y scAAV full 1 -m64011_220616_211638/178913597/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/178915073/ccs 969 Y Y tandem right-partial 1 -m64011_220616_211638/178979323/ccs/fwd 1241 Y Y scAAV right-partial 1 -m64011_220616_211638/178980911/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/178981572/ccs 3039 Y Y scAAV right-partial 1 -m64011_220616_211638/179046374/ccs 3230 Y Y scAAV right-partial 1 -m64011_220616_211638/179111372/ccs 1172 Y Y scAAV left-partial 1 -m64011_220616_211638/179111427/ccs 2462 Y N ssAAV full 2 -m64011_220616_211638/179176259/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/179242532/ccs 4698 Y Y scAAV full 1 -m64011_220616_211638/179242825/ccs 2130 Y Y scAAV right-partial 1 -m64011_220616_211638/179243512/ccs 2466 Y N ssAAV full 2 -m64011_220616_211638/179373432/ccs/fwd 2978 Y Y tandem right-partial 1 -m64011_220616_211638/179373866/ccs/rev 1850 Y Y scAAV right-partial 1 -m64011_220616_211638/179374727/ccs/rev 4036 N N NA NA 1 -m64011_220616_211638/179505633/ccs/fwd 3907 Y Y repcap NA 1 -m64011_220616_211638/179505965/ccs 2452 Y N ssAAV full 2 -m64011_220616_211638/179568710/ccs 2041 Y Y scAAV right-partial 1 -m64011_220616_211638/179701729/ccs 1609 Y N unclassified right-partial 1 -m64011_220616_211638/179766232/ccs 2366 Y Y tandem full|right-partial 1 -m64011_220616_211638/179767490/ccs/rev 4926 Y Y scAAV full 1 -m64011_220616_211638/179832214/ccs/rev 4633 Y Y scAAV full 1 -m64011_220616_211638/179832893/ccs/rev 3351 Y Y scAAV left-partial 1 -m64011_220616_211638/179832973/ccs/fwd 3612 Y Y scAAV right-partial 1 -m64011_220616_211638/179962516/ccs 4781 Y Y scAAV full 1 -m64011_220616_211638/179964463/ccs 2454 Y N ssAAV full 2 -m64011_220616_211638/180027625/ccs/rev 4694 Y Y scAAV full 1 -m64011_220616_211638/180027872/ccs 2953 Y Y scAAV left-partial 1 -m64011_220616_211638/180029848/ccs 4765 Y Y scAAV full 1 -m64011_220616_211638/180095496/ccs 2449 Y N ssAAV full 2 -m64011_220616_211638/180158569/ccs 4638 Y Y scAAV full 1 -m64011_220616_211638/180159027/ccs 2511 Y N ssAAV full 2 -m64011_220616_211638/180159618/ccs/rev 4960 Y Y scAAV full 1 -m64011_220616_211638/180159856/ccs/rev 2415 Y Y scAAV left-partial 1 -m64011_220616_211638/180160571/ccs 2487 Y N ssAAV full 2 -m64011_220616_211638/180357640/ccs/fwd 565 Y N ssAAV partial 1 -m64011_220616_211638/180423106/ccs 4689 Y Y scAAV full 1 -m64011_220616_211638/180423443/ccs/rev 3038 Y Y scAAV right-partial 1 -m64011_220616_211638/180486259/ccs 2747 N N NA NA 1 diff --git a/test/samples/in-metadata.tsv b/test/samples/in-metadata.tsv new file mode 100644 index 0000000..35aa587 --- /dev/null +++ b/test/samples/in-metadata.tsv @@ -0,0 +1,3 @@ +sample_unique_id sample_display_name +sc.subsample005 scAAV +ss.subsample005 ssAAV diff --git a/test/test_outputs.py b/test/test_outputs.py new file mode 100644 index 0000000..fa96b10 --- /dev/null +++ b/test/test_outputs.py @@ -0,0 +1,103 @@ +"""Test the outputs of the local LAAVA commands. + +Usage: pytest test_outputs.py + +Before running this test suite, first run the LAAVA commands using the accompanying +Makefile. That will generate the outputs this test suite looks for. +""" + +from pathlib import Path + +import pandas as pd +import pysam +import pytest + +EXPECTED_ROW_COUNTS = { + "sc": { + "alignments": 3349, + "per_read": 1687, + "metadata": 1, + "reference_names": 8, + "nonmatch": 52620, + }, + "ss": { + "alignments": 5489, + "per_read": 3517, + "flipflop": 2576, + "metadata": 1, + "reference_names": 8, + "nonmatch": 78330, + }, +} + +BUILD_DIR = "build" + + +class TestCompareTSVs: + @pytest.fixture(scope="class") + def build_dir(self): + return Path(BUILD_DIR) + + def check_row_count(self, path, expected_count): + df = pd.read_csv(path, sep="\t") + assert ( + len(df) == expected_count + ), f"Expected {expected_count} rows, got {len(df)} for {path}" + return df + + @pytest.mark.parametrize("name_prefix", EXPECTED_ROW_COUNTS.keys()) + def test_alignments(self, build_dir, name_prefix): + path = build_dir / f"{name_prefix}.alignments.tsv.gz" + expected_count = EXPECTED_ROW_COUNTS[name_prefix]["alignments"] + self.check_row_count(path, expected_count) + + @pytest.mark.parametrize("name_prefix", EXPECTED_ROW_COUNTS.keys()) + def test_per_read(self, build_dir, name_prefix): + tsv_path = build_dir / f"{name_prefix}.per_read.tsv.gz" + bam_path = Path(f"samples/{name_prefix}.subsample005.bam") + expected_count = EXPECTED_ROW_COUNTS[name_prefix]["per_read"] + + df = self.check_row_count(tsv_path, expected_count) + + with pysam.AlignmentFile(bam_path, "rb") as bam_file: + primary_count = sum( + 1 + for read in bam_file + if not read.is_secondary and not read.is_supplementary + ) + + assert ( + len(df) == expected_count == primary_count + ), f"Expected {expected_count} primary reads, got {len(df)} in TSV and {primary_count} in SAM for {tsv_path}" + + @pytest.mark.parametrize("name_prefix", EXPECTED_ROW_COUNTS.keys()) + def test_metadata(self, build_dir, name_prefix): + path = build_dir / f"{name_prefix}.metadata.tsv" + expected_count = EXPECTED_ROW_COUNTS[name_prefix]["metadata"] + self.check_row_count(path, expected_count) + + @pytest.mark.parametrize("name_prefix", EXPECTED_ROW_COUNTS.keys()) + def test_reference_names(self, build_dir, name_prefix): + tsv_path = build_dir / f"{name_prefix}.reference_names.tsv" + bam_path = build_dir / f"{name_prefix}.tagged.bam" + expected_count = EXPECTED_ROW_COUNTS[name_prefix]["reference_names"] + + df = self.check_row_count(tsv_path, expected_count) + + with pysam.AlignmentFile(bam_path, "rb") as bam_file: + sn_count = len(bam_file.references) + + assert ( + len(df) == expected_count == sn_count + ), f"Expected {expected_count} references, got {len(df)} in TSV and {sn_count} in BAM for {tsv_path}" + + @pytest.mark.parametrize("name_prefix", EXPECTED_ROW_COUNTS.keys()) + def test_nonmatch(self, build_dir, name_prefix): + path = build_dir / f"{name_prefix}.nonmatch.tsv.gz" + expected_count = EXPECTED_ROW_COUNTS[name_prefix]["nonmatch"] + self.check_row_count(path, expected_count) + + def test_ss_flipflop(self, build_dir): + path = build_dir / "ss.flipflop.tsv.gz" + expected_count = EXPECTED_ROW_COUNTS["ss"]["flipflop"] + self.check_row_count(path, expected_count) diff --git a/workflows/laava/inputs.md b/workflows/laava/inputs.md index 4607606..fa867a1 100644 --- a/workflows/laava/inputs.md +++ b/workflows/laava/inputs.md @@ -76,8 +76,6 @@ These string inputs are used to guide the handling of the file inputs above. - Vector type - Whether the vector construct is designed to be single-stranded AAV (ssAAV), self-complementary AAV (scAAV), or unknown/unspecified. -- ITR AAV Serotype - - Serotype name for ITR flip/flop analysis, e.g. "AAV2", or leave blank to skip. - Thresholds for "full" read classification - Target gap threshold - Max allowed outside vector diff --git a/workflows/laava/outputs.md b/workflows/laava/outputs.md index dfc8186..6f41458 100644 --- a/workflows/laava/outputs.md +++ b/workflows/laava/outputs.md @@ -6,23 +6,16 @@ - HTML report: SampleID_AAV_report.html - PDF report: SampleID_AAV_report.pdf -- Summary tables - - SampleID.alignments.tsv - - SampleID.readsummary.tsv - - SampleID.sequence-error.tsv - - SampleID.flipflop.tsv - - SampleID.Rdata - - ### Supplementary data files - Alignment files - Mapped reads: SampleID.sort_by_name.sam - Tagged reads: SampleID.tagged.bam - - Refence names: reference_names.tsv + - Reference names: SampleID.reference_names.tsv -- Read count and classification tables - - SampleID.nonmatch_stat.tsv.gz - - SampleID.per_read.tsv - - SampleID.summary.tsv - - SampleID.flipflop_assignments.txt (optional) +- Summary tables + - SampleID.metadata.tsv + - SampleID.alignments.tsv.gz + - SampleID.per_read.tsv.gz + - SampleID.nonmatch.tsv.gz + - SampleID.flipflop.tsv.gz (optional) diff --git a/workflows/laava/overview.md b/workflows/laava/overview.md index 807360f..fdfa8e4 100644 --- a/workflows/laava/overview.md +++ b/workflows/laava/overview.md @@ -10,10 +10,12 @@ analysis results and supporting tabular data. ``` mermaid graph TD -bam(Aligned BAM) --> counts(Read counts) -anno(Annotation BED) --> counts -counts --> sumtables(Summary tables) -counts --> sumreport(PDF/HTML Report) +seqreads(Sequencing reads) --> bam(Read alignment) +refseqs(Reference sequences) --> bam +bam --> sumtables(Summary data tables) +anno(Annotation) --> sumtables +meta(Sample metadata) --> sumtables +sumtables --> report(Report) ``` ## Methods @@ -24,16 +26,18 @@ PacBio sequencer (Sequel II, Sequel IIe or Revio) run with on-instrument AAV mode enabled, or equivalent circular consensus sequencing (CCS) reads (Travers et al., 2010) -In this analysis, HiFi/CCS sequencing reads are aligned to the construct, -packaging, and host reference sequences using Minimap2 (Li, 2018). -Aligned reads are filtered for quality to include primary alignments and reads -with mapping quality scores greater than 10. -The alignment coordinates and orientation of reads passing these filters are -then compared to the annotated vector region in the reference sequence, which -comprises the left and right ITRs and the genomic region between them, to -assign each read to a type and (for AAV reads) subtype classification according -to the definitions detailed in the report. +In this analysis, reads are aligned to the given AAV, packaging, and host reference +sequences using Minimap2 (Li, 2018). +The reference sequences for each primary alignment and its orientation are counted and +summarized to assign read type classifications, including vector, non-vector, and +chimeric reads. +For reads assigned to the AAV vector, the primary alignment coordinates are compared to +the annotated vector region in the reference sequence, which comprises the left and +right ITRs and the genomic region between them, to assign each read to a subtype +classification. +Sequence variants relative to the vector reference sequence are determined directly from +each read's alignment, specifically the CIGAR string indicating insertions, deletions, +mismatches, and gaps. Finally, a report is generated with relevant quality metrics and analysis results in both HTML and PDF formats. - diff --git a/workflows/laava/workflow.json b/workflows/laava/workflow.json index 8780515..8c876c8 100644 --- a/workflows/laava/workflow.json +++ b/workflows/laava/workflow.json @@ -10,9 +10,6 @@ "Gene Therapy", "PacBio" ], - "config": { - "executionEngine": "nextflow-single-node" - }, "inputs": { "ui_source_type": { "title": "Sequence input source (file or folder)", @@ -26,7 +23,7 @@ "id": "file_source" }, { - "name": "Folder (FASTQs)", + "name": "Folder (containing BAM or FASTQ files)", "id": "folder_source" } ] @@ -54,7 +51,7 @@ "sample_unique_id": { "title": "Sample unique ID", "description": "Sample's barcode number or other unique ID", - "help_text": "A unique identifier to distinguish the sample from others in the same sequencing run. This may be the barcode number used in the sample sheet, or a generated UUID.", + "help_text": "A unique identifier to distinguish the sample from others in the same sequencing run. This may be the barcode number used in the sample sheet, or a generated UUID. This string must also be present in the input sequencing reads BAM/FASTQ filename, i.e. that input filename starts with this ID or contains it as a substring.", "format": "text", "hidden": false, "required": false, @@ -74,21 +71,32 @@ "sample_in_metadata": { "title": "Sample metadata", "description": "Unique ID and display name for each sample (TSV)", - "help_text": "Two-column, tab-separated file with headers 'sample_unique_id' (e.g. barcode number, unique within a sequencing run) and 'sample_display' name (to display in the report, not required to be unique).", + "help_text": "Two-column, tab-separated file with headers 'sample_unique_id' (e.g. barcode number, unique within a sequencing run) and 'sample_display' name (to display in the report, not required to be unique). Each sample unique ID (column 1) must be present in exactly one sequencing reads filename (BAM/FASTQ), as a prefix or substring, so that each of these metadata rows can be mapped 1:1 to an input sequencing reads file.", "format": "spreadsheet", + "filetype": ".tsv", "hidden": true, "required": false, "type": "string", "columnConfig": { - ".tsv|.txt": { + ".tsv": { "staticColumns": false, "columns": [ { "name": "sample_unique_id", + "generateFromData": true, + "generateConfig": { + "delimiterPattern": "(\\.bam|\\.hifireads|\\.fastq|\\.fq)", + "dataName": "seq_reads_folder" + }, "required": true }, { "name": "sample_display_name", + "generateFromData": true, + "generateConfig": { + "delimiterPattern": "(\\.bam|\\.hifireads|\\.fastq|\\.fq)", + "dataName": "seq_reads_folder" + }, "required": true } ] @@ -96,7 +104,7 @@ } }, "vector_type": { - "title": "Vector type", + "title": "Construct vector type", "description": "Single-stranded or self-complementary", "help_text": "Whether the vector construct is designed to be single-stranded AAV (ssAAV), self-complementary AAV (scAAV), or unknown/unspecified.", "format": "radio", @@ -106,11 +114,11 @@ "enum": [ { "name": "Single-stranded AAV (ssAAV)", - "id": "ssaav" + "id": "ss" }, { "name": "Self-complementary AAV (scAAV)", - "id": "scaav" + "id": "sc" }, { "name": "Unknown / Unspecified", @@ -265,7 +273,7 @@ "max_allowed_outside_vector": { "title": "Max allowed outside vector", "description": "", - "help": "Maximum allowed, in bp, outside the annotated vector region for a read that fully covers the vector region to be still considered 'full' rather than 'vector+backbone'.", + "help_text": "Maximum allowed, in bp, outside the annotated vector region for a read that fully covers the vector region to be still considered 'full' rather than 'vector+backbone'.", "type": "integer", "hidden": false, "required": true, @@ -276,7 +284,7 @@ "max_allowed_missing_flanking": { "title": "Max allowed missing from ITR flank", "description": "", - "help": "Maximum allowed, in bp, missing from the left and right flanks of the annotated vector region to be still considered 'full' rather than 'partial'.", + "help_text": "Maximum allowed, in bp, missing from the left and right flanks of the annotated vector region to be still considered 'full' rather than 'partial'.", "type": "integer", "hidden": false, "required": true,