_            _    _        _         _
      /\ \         /\ \ /\ \     /\_\      / /\
      \_\ \       /  \ \\ \ \   / / /     / /  \
      /\__ \     / /\ \ \\ \ \_/ / /     / / /\ \__
     / /_ \ \   / / /\ \ \\ \___/ /     / / /\ \___\
    / / /\ \ \ / / /  \ \_\\ \ \_/      \ \ \ \/___/
   / / /  \/_// / /   / / / \ \ \        \ \ \
  / / /      / / /   / / /   \ \ \   _    \ \ \
 / / /      / / /___/ / /     \ \ \ /_/\__/ / /
/_/ /      / / /____\/ /       \ \_\\ \/___/ /
\_\/       \/_________/         \/_/ \_____\/

Enter the query into the form above. You can look for specific version of a package by using @ symbol like this: gcc@10.

API method:

GET /api/packages?search=hello&page=1&limit=20

where search is your query, page is a page number and limit is a number of items on a single page. Pagination information (such as a number of pages and etc) is returned in response headers.

If you'd like to join our channel webring send a patch to ~whereiseveryone/toys@lists.sr.ht adding your channel as an entry in channels.scm.


fastahack 1.0.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/ekg/fastahack
Licenses: Expat GPL 2
Synopsis: Indexing and sequence extraction from FASTA files
Description:

Fastahack is a small application for indexing and extracting sequences and subsequences from FASTA files. The included library provides a FASTA reader and indexer that can be embedded into applications which would benefit from directly reading subsequences from FASTA files. The library automatically handles index file generation and use.

r-bedtorch 0.1.12.12-1.f5ff4f8
Propagated dependencies: r-assertthat@0.2.1 r-curl@6.2.3 r-data-table@1.17.4 r-dplyr@1.1.4 r-genomeinfodb@1.44.0 r-genomicranges@1.60.0 r-purrr@1.0.4 r-r-utils@2.13.0 r-rcpp@1.0.14 r-rcurl@1.98-1.17 r-readr@2.1.5 r-rhtslib12@1.23.2-1.ee186da r-s4vectors@0.46.0 r-stringr@1.5.1 r-tidyr@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/haizi-zh/bedtorch/
Licenses: Expat
Synopsis: R package for fast BED-file manipulation
Description:

The goal of bedtorch is to provide a fast BED file manipulation tool suite native in R.

python-presto 0.7.6
Propagated dependencies: muscle@3.8.1551 python-biopython@1.85 python-numpy@1.26.4 python-pandas@2.2.3 python-pyyaml@6.0.2 python-scipy@1.12.0 vsearch@2.9.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/immcantation/presto
Licenses: AGPL 3
Synopsis: The REpertoire Sequencing TOolkit
Description:

Presto is a python toolkit for processing raw reads from high-throughput sequencing of B cell and T cell repertoires.

perl-bio-db-hts 3.01
Propagated dependencies: bioperl-minimal@1.7.0 htslib@1.9
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://metacpan.org/release/Bio-DB-HTS
Licenses: ASL 2.0
Synopsis: Perl interface to HTS library for DNA sequencing
Description:

This is a Perl interface to the HTS library for DNA sequencing.

r-pizzarr 0.1.0-1.7b3fd72
Propagated dependencies: r-jsonlite@2.0.0 r-memoise@2.0.1 r-qs@0.27.3 r-r6@2.6.1 r-stringr@1.5.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/keller-mark/pizzarr
Licenses: Expat
Synopsis: Slice into Zarr arrays in R
Description:

This package provides an implementation of chunked, compressed, N-dimensional arrays for R, Zarr specification version 2 (2024) <doi:10.5281/zenodo.11320255>.

python-vireosnp 0.5.9-0.e365463
Propagated dependencies: python-matplotlib@3.8.2 python-numpy@1.26.4 python-scipy@1.12.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/huangyh09/vireoSNP
Licenses: ASL 2.0
Synopsis: Deconvolution based on SNP for multiplexed scRNA-seq data
Description:

This package provides a deconvolution based on Single Nucleotide Position (SNP) for multiplexed scRNA-seq data. The name vireo stand for Variational Inference for Reconstructing Ensemble Origin by expressed SNPs in multiplexed scRNA-seq data and follows the clone identification from single-cell data named cardelino.

mosaik 2.2.30
Dependencies: perl@5.36.0 zlib@1.3.1 zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/wanpinglee/MOSAIK
Licenses: GPL 2+ Public Domain
Synopsis: Map nucleotide sequence reads to reference genomes
Description:

MOSAIK is a program for mapping second and third-generation sequencing reads to a reference genome. MOSAIK can align reads generated by all the major sequencing technologies, including Illumina, Applied Biosystems SOLiD, Roche 454, Ion Torrent and Pacific BioSciences SMRT.

pbgzip 0.0.0-0.2b09f97
Dependencies: zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/nh13/pbgzip
Licenses: Expat
Synopsis: Parallel Block GZIP
Description:

This package implements parallel block gzip. For many formats, in particular genomics data formats, data are compressed in fixed-length blocks such that they can be easily indexed based on a (genomic) coordinate order, since typically each block is sorted according to this order. This allows for each block to be individually compressed (deflated), or more importantly, decompressed (inflated), with the latter enabling random retrieval of data in large files (gigabytes to terabytes). pbgzip is not limited to any particular format, but certain features are tailored to genomics data formats when enabled. Parallel decompression is somewhat faster, but the true speedup comes during compression.

crossmap 0.6.1
Dependencies: python-bx-python@0.14.0 python-numpy@1.26.4 python-pybigwig@0.3.22 python-pysam@0.23.0 zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://crossmap.sourceforge.net/
Licenses: GPL 2+
Synopsis: Convert genome coordinates between assemblies
Description:

CrossMap is a program for conversion of genome coordinates or annotation files between different genome assemblies. It supports most commonly used file formats including SAM/BAM, Wiggle/BigWig, BED, GFF/GTF, VCF.

r-copykat 1.0.8-0.256de33
Propagated dependencies: r-cluster@2.1.8.1 r-dlm@1.1-6.1 r-gplots@3.2.0 r-mcmcpack@1.7-1 r-mixtools@2.0.0.1 r-paralleldist@0.2.6 r-rcolorbrewer@1.1-3
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/navinlabcode/copykat
Licenses: GPL 2
Synopsis: Inference of genomic copy number from single cell RNAseq data
Description:

This package Copynumber KAryotyping of Tumors infers genomic copy number and subclonal structure of human tumors using integrative Bayesian approaches to identify genome-wide aneuploidy at 5MB resolution in single cells data. It separates tumor cells and tumor subclones from normal cells using high-throughput sc-RNAseq data.

cnvkit 0.9.12
Dependencies: r-minimal@4.5.0
Propagated dependencies: python-biopython@1.85 python-future@1.0.0 python-matplotlib@3.8.2 python-numpy@1.26.4 python-pandas@2.2.3 python-pomegranate@0.14.8 python-pyfaidx@0.7.2.1 python-pysam@0.23.0 python-reportlab@4.0.8 python-scikit-learn@1.7.0 python-scipy@1.12.0 r-dnacopy@1.82.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://cnvkit.readthedocs.org/
Licenses: ASL 2.0
Synopsis: Copy number variant detection from targeted DNA sequencing
Description:

CNVkit is a Python library and command-line software toolkit to infer and visualize copy number from high-throughput DNA sequencing data. It is designed for use with hybrid capture, including both whole-exome and custom target panels, and short-read sequencing platforms such as Illumina and Ion Torrent.

python-pegasusio 0.9.1
Propagated dependencies: python-anndata@0.12.1 python-cython@3.1.2 python-docopt@0.6.2 python-h5py@3.13.0 python-loompy@3.0.7 python-natsort@8.4.0 python-numpy@1.26.4 python-pandas@2.2.3 python-pillow@11.1.0 python-scipy@1.12.0 python-setuptools@80.9.0 python-zarr@2.18.7
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/lilab-bcb/pegasusio
Licenses: Modified BSD
Synopsis: Read or write single-cell genomics data
Description:

Pegasusio is a Python package for reading or writing single-cell genomics data.

ruby-bio-kseq 0.0.2
Dependencies: zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/gusevfe/bio-kseq
Licenses: Expat
Synopsis: Ruby bindings for the kseq.h FASTA/Q parser
Description:

Bio::Kseq provides ruby bindings to the kseq.h FASTA and FASTQ parsing code. It provides a fast iterator over sequences and their quality scores.

python-scikit-bio 0.6.0
Propagated dependencies: python-biom-format@2.1.16 python-decorator@5.2.1 python-h5py@3.13.0 python-hdmedians@0.14.2 python-natsort@8.4.0 python-numpy@1.26.4 python-pandas@2.2.3 python-requests@2.32.5 python-scipy@1.12.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://scikit-bio.org
Licenses: Modified BSD
Synopsis: Data structures, algorithms and educational resources for bioinformatics
Description:

This package provides data structures, algorithms and educational resources for bioinformatics.

wfa2-lib 2.3.3
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/smarco/WFA2-lib
Licenses: Expat
Synopsis: Wavefront alignment algorithm library
Description:

The wavefront alignment (WFA) algorithm is an exact gap-affine algorithm that takes advantage of homologous regions between the sequences to accelerate the alignment process.

filevercmp 0-1.1a9b779
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/ekg/filevercmp
Licenses: GPL 3+
Synopsis: This program compares version strings
Description:

This program compares version strings. It intends to be a replacement for strverscmp.

python-biofluff 3.0.4
Propagated dependencies: htseq@2.0.2 python-matplotlib@3.8.2 python-numpy@1.26.4 python-palettable@3.3.3 python-pybedtools@0.10.0 python-pybigwig@0.3.22 python-pysam@0.23.0 python-scikit-learn@1.7.0 python-scipy@1.12.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/simonvh/fluff/
Licenses: Expat
Synopsis: Analysis and visualization of high-throughput sequencing data
Description:

Fluff is a Python package that contains several scripts to produce pretty, publication-quality figures for next-generation sequencing experiments.

python-scdamandtools 1.0
Propagated dependencies: python-h5py@3.13.0 python-numpy@1.26.4 python-sortedcontainers@2.4.0 python-pandas@2.2.3 python-pysam@0.23.0 python-tqdm@4.67.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/KindLab/scDamAndTools
Licenses: Expat
Synopsis: Functions for processing raw scDam&T-seq data
Description:

This is a set of functions for processing raw scDam&T-seq data. scDam&T-seq is a method to simultaneously measure protein-DNA interactions and transcription from single cells (Rooijers et al., 2019). It combines a DamID-based method to measure protein-DNA interactions and an adaptation of CEL-Seq to measure transcription. The starting point of the workflow is raw sequencing data and the end result are tables of UMI-unique DamID and CEL-Seq counts.

phylip 3.697
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://evolution.genetics.washington.edu/phylip/
Licenses: FreeBSD
Synopsis: Tools for inferring phylogenies
Description:

PHYLIP (the PHYLogeny Inference Package) is a package of programs for inferring phylogenies (evolutionary trees).

diamond 2.1.6
Dependencies: zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/bbuchfink/diamond
Licenses: GPL 3+
Synopsis: Accelerated BLAST compatible local sequence aligner
Description:

DIAMOND is a BLAST-compatible local aligner for mapping protein and translated DNA query sequences against a protein reference database (BLASTP and BLASTX alignment mode). The speedup over BLAST is up to 20,000 on short reads at a typical sensitivity of 90-99% relative to BLAST depending on the data and settings.

r-pando 1.0.5
Propagated dependencies: r-bayestestr@0.16.0 r-foreach@1.5.2 r-genomicranges@1.60.0 r-ggplot2@3.5.2 r-ggpointdensity@0.2.0 r-ggraph@2.2.1 r-glmnetutils@1.1.9 r-grr@0.9.5 r-iranges@2.42.0 r-irlba@2.3.5.1 r-matrix@1.7-3 r-matrixgenerics@1.20.0 r-motifmatchr@1.30.0 r-pals@1.10 r-patchwork@1.3.0 r-seurat@5.3.0 r-signac@1.12.0-1.8ecdde2 r-sparsematrixstats@1.20.0 r-tfbstools@1.46.0 r-tidygraph@1.3.1 r-tidyverse@2.0.0 r-uwot@0.2.3
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/quadbiolab/Pando
Licenses: Expat
Synopsis: Infer regulomes from multi-modal single-cell genomics data
Description:

Pando leverages multi-modal single-cell measurements to infer gene regulatory networks using a flexible linear model-based framework. By modeling the relationship between TF-binding site pairs with the expression of target genes, Pando simultaneously infers gene modules and sets of regulatory regions for each transcription factor.

pigx-sars-cov-2 0.0.9
Dependencies: bash-minimal@5.2.37 bedtools@2.31.1 bwa@0.7.18 ensembl-vep@112 fastp@0.23.2 fastqc@0.11.9 ivar@1.4.4 kraken2@2.1.2 krona-tools@2.8 lofreq@2.1.5 multiqc@1.14 python-pyyaml@6.0.2 python-wrapper@3.11.11 r-base64url@1.4 r-data-table@1.17.4 r-deconvr@1.14.0 r-dplyr@1.1.4 r-dt@0.33 r-ggplot2@3.5.2 r-htmltools@0.5.8.1 r-jsonlite@2.0.0 r-knitr@1.50 r-magrittr@2.0.3 r-mass@7.3-65 r-minimal@4.5.0 r-plotly@4.10.4 r-qpcr@1.4-1 r-r-utils@2.13.0 r-reshape2@1.4.4 r-rmarkdown@2.29 r-stringr@1.5.1 r-tidyr@1.3.1 r-viridis@0.6.5 samtools@1.19 snakemake@7.32.4 wget@1.25.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://bioinformatics.mdc-berlin.de/pigx/
Licenses: GPL 3+
Synopsis: Analysis pipeline for wastewater sequencing
Description:

PiGx SARS-CoV-2 is a pipeline for analysing data from sequenced wastewater samples and identifying given variants-of-concern of SARS-CoV-2. The pipeline can be used for continuous sampling. The output report will provide an intuitive visual overview about the development of variant abundance over time and location.

python-multivelo 0.1.2
Propagated dependencies: python-anndata@0.12.1 python-h5py@3.13.0 python-ipywidgets@8.1.2 python-joblib@1.5.1 python-loompy@3.0.7 python-matplotlib@3.8.2 python-numba@0.61.0 python-numpy@1.26.4 python-pandas@2.2.3 python-scanpy@1.11.2 python-scikit-learn@1.7.0 python-scipy@1.12.0 python-seaborn@0.13.2 python-tqdm@4.67.1 python-umap-learn@0.5.9 scvelo@0.2.4
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/welch-lab/MultiVelo
Licenses: Modified BSD
Synopsis: Velocity inference from single-cell multi-omic data
Description:

MultiVelo uses a probabilistic latent variable model to estimate the switch time and rate parameters of gene regulation, providing a quantitative summary of the temporal relationship between epigenomic and transcriptomic changes.

r-skitools 0.0.0.9000-1.22d107d
Propagated dependencies: r-biostrings@2.76.0 r-complexheatmap@2.24.0 r-data-table@1.17.4 r-devtools@2.4.5 r-dt@0.33 r-gchain@0.2.0-1.dc393e8 r-genomeinfodb@1.44.0 r-genomicranges@1.60.0 r-ggplot2@3.5.2 r-gplots@3.2.0 r-gutils@0.2.0-2.fc24db6 r-htmlwidgets@1.6.4 r-hwriter@1.3.2.1 r-igraph@2.1.4 r-iranges@2.42.0 r-plotly@4.10.4 r-rcolorbrewer@1.1-3 r-reshape2@1.4.4 r-s4vectors@0.46.0 r-stringr@1.5.1 r-variantannotation@1.54.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/mskilab/skitools/
Licenses: Expat
Synopsis: Various mskilab R utilities
Description:

This package provides R miscellaneous utilities for basic data manipulation, debugging, visualization, lsf management, and common mskilab tasks.

Page: 123456789101112131415161718192021222324252627282930313233343536373839404142434445464748495051525354555657585960616263646566676869707172737475767778798081828384858687888990919293949596979899100101102103104105106107108109110111112113114115116117118119120121122123124125126127128129130131132133134135136137138139140141142143144145146147148149150151152153154155156157158159160161162163164165166167168169170171172173174175176177178179180181182183184185186187188189190191192193194195196197198199200201202203204205206207208209210211212213214215216217218219220221222223224225226227228229230231232233234235236237238239240241242243244245246247248249250251252253254255256257258259260261262263264265266267268269270271272273274275276277278279280281282283284285286287288289290291292293294295296297298299300301302303304305306307308309310311312313314315316317318319320321322323324325326327328329330331332333334335336337338339340341342343344345346347348349350351352353354355356357358359360361362363364365366367368369370371372373374375376377378379380381382383384385386387388389390391392393394395396397398399400401402403404405406407408409410411412413414415416417418419420421422423424425426427428429430431432433434435436437438439440441442443444445446447448449450451452453454455456457458459460461462463464465466467468469470471472473474475476477478479480481482483484485486487488489490491492493494495496497498499500501502503504505506507508509510511512513514515516517518519520521522523524525526527528529530531532533534535536537538539540541542543544545546547548549550551552553554555556557558559560561562563564565566567568569570571572573574575576577578579580581582583584585586587588589590591592593594595596597598599600601602603604605606607608609610611612613614615616617618619620621622623624625626627628629630631632633634635636637638639640641642643644645646647648649650651652653654655656657658659660661662663664665666667668669670671672673674675676677678679680681682683684685686687688689690691692693694695696697698699700701702703704705706707708709710711712713714715716717718719720721722723724725726727728729730731732733734735736737738739740741742743744745746747748749750751752753754755756757758759760761762763764765766767768769770771772773774775776777778779780781782783784785786787788789790791792793794795796797798799800801802803804805806807808809810811812813814815816817818819820821822823824825826827828829830831832833834835836837838839840841842843844845846847848849850851852853854855856857858859860861862863864865866867868869870871872873874875876877878879880881882883884885886887888889890891892893894895896897898899900901902903904905906907908909910911912913914915916917918919920921922923924925926927928929930931932933934935936937938939940941942943944945946947948949950951952953954955956957958959960961962963964965966967968969970971972973974975976977978979980981982983984985986987988989990991992993994995996997998999100010011002100310041005100610071008100910101011101210131014101510161017101810191020102110221023102410251026102710281029103010311032103310341035103610371038103910401041104210431044104510461047104810491050105110521053105410551056105710581059106010611062106310641065106610671068106910701071107210731074107510761077107810791080108110821083108410851086108710881089109010911092109310941095109610971098109911001101110211031104110511061107110811091110111111121113111411151116111711181119112011211122112311241125112611271128112911301131113211331134113511361137113811391140114111421143114411451146114711481149115011511152115311541155115611571158115911601161116211631164116511661167116811691170117111721173117411751176117711781179118011811182118311841185118611871188118911901191119211931194119511961197119811991200120112021203120412051206120712081209121012111212121312141215121612171218121912201221122212231224122512261227122812291230123112321233123412351236123712381239124012411242124312441245124612471248124912501251125212531254125512561257125812591260126112621263126412651266126712681269127012711272127312741275127612771278127912801281128212831284128512861287128812891290129112921293129412951296129712981299130013011302130313041305130613071308130913101311131213131314131513161317131813191320132113221323132413251326132713281329133013311332133313341335133613371338133913401341134213431344134513461347134813491350135113521353135413551356135713581359136013611362136313641365136613671368136913701371137213731374137513761377137813791380138113821383138413851386138713881389139013911392139313941395139613971398139914001401140214031404140514061407140814091410141114121413141414151416141714181419142014211422142314241425142614271428142914301431143214331434143514361437143814391440144114421443144414451446144714481449145014511452145314541455145614571458145914601461146214631464146514661467146814691470147114721473147414751476147714781479148014811482148314841485148614871488148914901491149214931494149514961497149814991500150115021503150415051506150715081509151015111512151315141515151615171518151915201521152215231524152515261527152815291530153115321533153415351536153715381539154015411542154315441545154615471548154915501551155215531554155515561557155815591560156115621563156415651566156715681569157015711572157315741575157615771578157915801581158215831584158515861587158815891590159115921593159415951596159715981599160016011602160316041605160616071608160916101611161216131614161516161617161816191620162116221623162416251626162716281629163016311632163316341635163616371638163916401641164216431644164516461647164816491650165116521653165416551656165716581659166016611662166316641665166616671668166916701671167216731674167516761677167816791680168116821683168416851686168716881689169016911692169316941695169616971698169917001701170217031704170517061707170817091710171117121713171417151716171717181719172017211722172317241725172617271728172917301731173217331734173517361737173817391740174117421743174417451746174717481749175017511752175317541755175617571758175917601761176217631764176517661767176817691770177117721773177417751776177717781779178017811782178317841785178617871788178917901791179217931794179517961797179817991800180118021803180418051806180718081809181018111812181318141815181618171818181918201821182218231824182518261827182818291830183118321833183418351836183718381839184018411842184318441845184618471848184918501851185218531854185518561857185818591860186118621863186418651866186718681869187018711872187318741875187618771878187918801881188218831884188518861887188818891890189118921893189418951896189718981899190019011902190319041905190619071908190919101911191219131914191519161917191819191920192119221923192419251926192719281929193019311932193319341935193619371938193919401941194219431944194519461947194819491950195119521953195419551956195719581959196019611962196319641965196619671968196919701971197219731974197519761977197819791980198119821983198419851986198719881989199019911992199319941995199619971998199920002001200220032004200520062007200820092010201120122013201420152016201720182019202020212022202320242025202620272028202920302031203220332034203520362037203820392040204120422043204420452046204720482049205020512052205320542055205620572058205920602061206220632064206520662067206820692070207120722073207420752076207720782079208020812082208320842085208620872088208920902091209220932094209520962097209820992100210121022103210421052106210721082109211021112112211321142115211621172118211921202121212221232124212521262127212821292130213121322133213421352136213721382139214021412142214321442145214621472148214921502151215221532154215521562157215821592160216121622163216421652166216721682169217021712172217321742175217621772178217921802181218221832184218521862187218821892190219121922193219421952196219721982199220022012202220322042205220622072208220922102211221222132214221522162217221822192220222122222223222422252226222722282229223022312232223322342235223622372238223922402241224222432244224522462247224822492250225122522253225422552256225722582259226022612262226322642265226622672268226922702271227222732274227522762277227822792280228122822283228422852286228722882289229022912292229322942295229622972298229923002301230223032304230523062307230823092310231123122313231423152316231723182319232023212322232323242325232623272328232923302331233223332334233523362337233823392340234123422343234423452346234723482349235023512352235323542355235623572358235923602361236223632364236523662367236823692370237123722373237423752376237723782379238023812382238323842385238623872388238923902391239223932394239523962397239823992400240124022403240424052406240724082409241024112412241324142415241624172418241924202421242224232424242524262427242824292430243124322433243424352436243724382439244024412442244324442445244624472448244924502451245224532454245524562457245824592460246124622463246424652466246724682469247024712472247324742475247624772478247924802481248224832484248524862487248824892490249124922493249424952496249724982499250025012502250325042505250625072508250925102511251225132514251525162517251825192520252125222523252425252526252725282529253025312532253325342535253625372538253925402541254225432544254525462547254825492550255125522553255425552556255725582559256025612562256325642565256625672568256925702571257225732574257525762577257825792580258125822583258425852586258725882589259025912592259325942595259625972598259926002601260226032604260526062607260826092610261126122613261426152616261726182619262026212622262326242625262626272628262926302631263226332634263526362637263826392640264126422643264426452646264726482649265026512652265326542655265626572658265926602661266226632664266526662667266826692670267126722673267426752676267726782679268026812682268326842685268626872688268926902691269226932694269526962697269826992700270127022703270427052706270727082709271027112712271327142715271627172718271927202721272227232724272527262727272827292730273127322733273427352736273727382739274027412742274327442745274627472748274927502751275227532754275527562757275827592760276127622763276427652766276727682769277027712772277327742775277627772778277927802781278227832784278527862787278827892790279127922793279427952796
Total results: 67086