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

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.


prinseq 0.20.4
Dependencies: guile@3.0.9 perl@5.36.0 perl-cairo@1.109 perl-data-dumper@2.183 perl-digest-md5@2.58 perl-getopt-long@2.51 perl-json@4.02 perl-statistics-pca@0.0.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://prinseq.sourceforge.net/
Licenses: GPL 3+
Synopsis: Preprocess sequence data in FASTA or FASTQ formats
Description:

PRINSEQ is a bioinformatics tool to help you preprocess your genomic or metagenomic sequence data in FASTA or FASTQ formats. The tool is written in Perl and can be helpful if you want to filter, reformat, or trim your sequence data. It also generates basic statistics for your sequences.

pigx 0.0.3
Dependencies: python@3.11.11 pigx-bsseq@0.1.10 pigx-chipseq@0.1.0 pigx-rnaseq@0.1.1 pigx-scrnaseq@1.1.10
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://bioinformatics.mdc-berlin.de/pigx/
Licenses: GPL 3+
Synopsis: Analysis pipelines for genomics
Description:

PiGx is a collection of genomics pipelines. It includes the following pipelines:

  • PiGx BSseq for raw fastq read data of bisulfite experiments

  • PiGx RNAseq for RNAseq samples

  • PiGx scRNAseq for single cell dropseq analysis

  • PiGx ChIPseq for reads from ChIPseq experiments

All pipelines are easily configured with a simple sample sheet and a descriptive settings file. The result is a set of comprehensive, interactive HTML reports with interesting findings about your samples.

scallop 0.10.5
Dependencies: boost@1.83.0 htslib@1.21
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/Kingsford-Group/scallop
Licenses: Modified BSD
Synopsis: Reference-based transcriptome assembler for RNA-seq
Description:

Scallop is a reference-based transcript assembler. Scallop features its high accuracy in assembling multi-exon transcripts as well as lowly expressed transcripts.

r-chromunity 0.0.2-2.101e30a
Propagated dependencies: r-arrow@21.0.0 r-biocgenerics@0.54.0 r-bsgenome-hsapiens-ucsc-hg38@1.4.5 r-data-table@1.17.4 r-gchain@0.2.0-1.dc393e8 r-genomicranges@1.60.0 r-gutils@0.2.0-2.fc24db6 r-igraph@2.1.4 r-magrittr@2.0.3 r-mass@7.3-65 r-matrix@1.7-3 r-pbmcapply@1.5.1 r-plyr@1.8.9 r-r6@2.6.1 r-zoo@1.8-14
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/mskilab/chromunity
Licenses: GPL 3
Synopsis: Discovery of communities in Pore-C concatemers
Description:

This is a package for the discovery of communities in Pore-C concatemers.

python-biopython 1.85
Propagated dependencies: python-numpy@1.26.4
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://biopython.org/
Licenses: non-copyleft
Synopsis: Tools for biological computation in Python
Description:

Biopython is a set of tools for biological computation including parsers for bioinformatics files into Python data structures; interfaces to common bioinformatics programs; a standard sequence class and tools for performing common operations on them; code to perform data classification; code for dealing with alignments; code making it easy to split up parallelizable tasks into separate processes; and more.

python-hotspotsc 1.1.1
Propagated dependencies: python-anndata@0.12.1 python-importlib-metadata@8.7.0 python-ipython@8.37.0 python-matplotlib@3.8.2 python-nbsphinx@0.8.8 python-numba@0.61.0 python-numpy@1.26.4 python-pandas@2.2.3 python-pynndescent@0.5.13 python-scanpy@1.11.2 python-scikit-learn@1.7.0 python-scipy@1.12.0 python-seaborn@0.13.2 python-statsmodels@0.14.4 python-tqdm@4.67.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/yoseflab/hotspot
Licenses: Expat
Synopsis: Identifying informative genes in a single-cell dataset
Description:

Hotspot is a tool for identifying informative genes (and gene modules) in a single-cell dataset. Importantly, "informative" is decided based on how well a gene's variation agrees with some cell metric---some similarity mapping between cells. Genes which are informative are those whose expression varies in similar way among cells which are nearby in the given metric.

kraken2 2.1.2
Dependencies: gzip@1.14 perl@5.36.0 rsync@3.4.1 sed@4.9 wget@1.25.0 which@2.21
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/DerrickWood/kraken2
Licenses: Expat
Synopsis: Taxonomic sequence classification system
Description:

Kraken is a taxonomic sequence classifier that assigns taxonomic labels to DNA sequences. Kraken examines the k-mers within a query sequence and uses the information within those k-mers to query a database. That database maps k-mers to the lowest common ancestor (LCA) of all genomes known to contain a given k-mer.

pardre 2.2.5
Dependencies: openmpi-c++@4.1.6 zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://sourceforge.net/projects/pardre/
Licenses: GPL 3+
Synopsis: Parallel tool to remove duplicate DNA reads
Description:

ParDRe is a parallel tool to remove duplicate genetic sequence reads. Duplicate reads can be seen as identical or nearly identical sequences with some mismatches. This tool lets users avoid the analysis of unnecessary reads, reducing the time of subsequent procedures with the dataset (e.g. assemblies, mappings, etc.). The tool is implemented with MPI in order to exploit the parallel capabilities of multicore clusters. It is faster than multithreaded counterparts (end of 2015) for the same number of cores and, thanks to the message-passing technology, it can be executed on clusters.

blasr-libcpp 5.3.5
Dependencies: boost@1.83.0 hdf5@1.14.6 htslib@1.21 pbbam@2.1.0 zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://web.archive.org/web/20201106122415/https://github.com/PacificBiosciences/blasr_libcpp
Licenses: Modified BSD
Synopsis: Library for analyzing PacBio genomic sequences
Description:

This package provides three libraries used by applications for analyzing PacBio genomic sequences. This library contains three sub-libraries: pbdata, hdf and alignment.

kaiju 1.9.0
Dependencies: bzip2@1.0.8 coreutils@9.1 curl@8.6.0 gawk@5.3.0 guile@3.0.9 gzip@1.14 perl@5.36.0 python-wrapper@3.11.11 tar@1.35 wget@1.25.0 zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://kaiju.binf.ku.dk/
Licenses: GPL 3+
Synopsis: Fast and sensitive taxonomic classification for metagenomics
Description:

Kaiju is a program for sensitive taxonomic classification of high-throughput sequencing reads from metagenomic whole genome sequencing experiments.

macs 3.0.2
Propagated dependencies: python-cykhash@2.0.1 python-hmmlearn@0.3.3 python-numpy@1.26.4 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/macs3-project/MACS
Licenses: Modified BSD
Synopsis: Model based analysis for ChIP-Seq data
Description:

MACS is an implementation of a ChIP-Seq analysis algorithm for identifying transcript factor binding sites named Model-based Analysis of ChIP-Seq (MACS). MACS captures the influence of genome complexity to evaluate the significance of enriched ChIP regions and it improves the spatial resolution of binding sites through combining the information of both sequencing tag position and orientation.

python-magic-impute 1.2.1
Propagated dependencies: python-future@1.0.0 python-graphtools@1.5.3 python-matplotlib@3.8.2 python-numpy@1.26.4 python-pandas@2.2.3 python-scikit-learn@1.7.0 python-scipy@1.12.0 python-tasklogger@1.2.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/KrishnaswamyLab/MAGIC
Licenses: GPL 2+
Synopsis: Markov affinity-based graph imputation of cells
Description:

MAGIC is an interactive tool to impute missing values in single-cell sequencing data and to restore the structure of the data. It also provides data pre-processing functionality such as dimensionality reduction and gene expression visualization.

multichoose 1.0.3
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/ekg/multichoose
Licenses: Expat
Synopsis: Efficient loopless multiset combination generation algorithm
Description:

This library implements an efficient loopless multiset combination generation algorithm which is (approximately) described in "Loopless algorithms for generating permutations, combinations, and other combinatorial configurations.", G. Ehrlich - Journal of the ACM (JACM), 1973. (Algorithm 7.)

python-deeptoolsintervals 0.1.9
Dependencies: zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/deeptools/deeptools_intervals
Licenses: Expat
Synopsis: Create GTF-based interval trees with associated meta-data
Description:

This package provides a Python module creating/accessing GTF-based interval trees with associated meta-data. It is primarily used by the deeptools package.

java-biojava-core 4.2.11
Propagated dependencies: java-log4j-api@2.17.1 java-log4j-core@2.17.1 java-slf4j-api@1.7.25 java-slf4j-simple@1.7.25
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://biojava.org
Licenses: LGPL 2.1+
Synopsis: Core libraries of Java framework for processing biological data
Description:

BioJava is a project dedicated to providing a Java framework for processing biological data. It provides analytical and statistical routines, parsers for common file formats, reference implementations of popular algorithms, and allows the manipulation of sequences and 3D structures. The goal of the biojava project is to facilitate rapid application development for bioinformatics.

This package provides the core libraries.

python-gseapy 1.0.4
Dependencies: python-wrapper@3.11.11
Propagated dependencies: python-numpy@1.26.4 python-scipy@1.12.0 python-pandas@2.2.3 python-matplotlib@3.8.2 python-requests@2.32.5
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/zqfang/gseapy
Licenses: Modified BSD
Synopsis: Gene Set Enrichment Analysis in Python
Description:

GSEApy is a Python/Rust implementation for GSEA and wrapper for Enrichr. GSEApy can be used for RNA-seq, ChIP-seq, Microarray data. It can be used for convenient GO enrichment and to produce publication quality figures in Python.

rsem 1.3.3
Dependencies: bash-minimal@5.2.37 boost@1.83.0 r-minimal@4.5.0 perl@5.36.0 htslib@1.3.1 zlib@1.3.1
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://deweylab.biostat.wisc.edu/rsem/
Licenses: GPL 3+
Synopsis: Estimate gene expression levels from RNA-Seq data
Description:

RSEM is a software package for estimating gene and isoform expression levels from RNA-Seq data. The RSEM package provides a user-friendly interface, supports threads for parallel computation of the EM algorithm, single-end and paired-end read data, quality scores, variable-length reads and RSPD estimation. In addition, it provides posterior mean and 95% credibility interval estimates for expression levels. For visualization, it can generate BAM and Wiggle files in both transcript-coordinate and genomic-coordinate.

edirect 13.3.20200128
Dependencies: bash-minimal@5.2.37 edirect-go-programs@13.3.20200128 perl-html-parser@3.72 perl-encode-locale@1.05 perl-file-listing@6.15 perl-html-tagset@3.20 perl-html-tree@5.07 perl-http-cookies@6.10 perl-http-date@6.05 perl-http-message@6.37 perl-http-negotiate@6.01 perl-lwp-mediatypes@6.04 perl-lwp-protocol-https@6.09 perl-net-http@6.22 perl-uri@5.05 perl-www-robotrules@6.02 perl-xml-simple@2.25 perl@5.36.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://www.ncbi.nlm.nih.gov/books/NBK179288/
Licenses: Public Domain
Synopsis: Tools for accessing the NCBI's set of databases
Description:

Entrez Direct (EDirect) is a method for accessing the National Center for Biotechnology Information's (NCBI) set of interconnected databases (publication, sequence, structure, gene, variation, expression, etc.) from a terminal. Functions take search terms from command-line arguments. Individual operations are combined to build multi-step queries. Record retrieval and formatting normally complete the process.

EDirect also provides an argument-driven function that simplifies the extraction of data from document summaries or other results that are returned in structured XML format. This can eliminate the need for writing custom software to answer ad hoc questions.

python-pyfaidx 0.7.2.1
Propagated dependencies: python-setuptools@80.9.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: http://mattshirley.com
Licenses: Modified BSD
Synopsis: Random access to fasta subsequences
Description:

This package provides procedures for efficient pythonic random access to fasta subsequences.

r-conospanel 1.0.0-1.39e76b2
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/kharchenkolab/conosPanel
Licenses: GPL 3
Synopsis: Data for the conos package
Description:

The data within this package is a panel of four samples, each with 3000 cells. There are two samples which are bone marrow (BM), and two samples which are cord blood (CB).

python-bwapy 0.1.4
Dependencies: zlib@1.3.1
Propagated dependencies: python-cffi@1.17.1 python-setuptools@80.9.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/ACEnglish/bwapy
Licenses: MPL 2.0
Synopsis: Python bindings to bwa aligner
Description:

This package provides Python bindings to the bwa mem aligner.

r-pairwiseadonis 0.4.1-1.cb190f7
Propagated dependencies: r-cluster@2.1.8.1 r-permute@0.9-7 r-vegan@2.6-10
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/pmartinezarbizu/pairwiseAdonis
Licenses: GPL 2+
Synopsis: Pairwise multilevel comparison using adonis
Description:

This package implements two functions:

  • pairwise.adonis is a wrapper function for multilevel pairwise comparison using adonis2 from package vegan. The function returns adjusted p-values using p.adjust(). It does not accept interaction between factors neither strata.

  • pairwise.adonis2 accepts a model formula like in adonis from vegan. You can use interactions between factors and define strata to constrain permutations. For pairwise comparison a list of unique pairwise combination of factors is produced.

tadbit 1.0.1-2.2838129
Dependencies: imp@2.23.0 mcl@14.137 python-future@1.0.0 python-h5py@3.13.0 python-scipy@1.12.0 python-numpy@1.26.4 python-matplotlib@3.8.2 python-pysam@0.23.0 r-minimal@4.5.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://3dgenomes.github.io/TADbit/
Licenses: GPL 3+
Synopsis: Analyze, model, and explore 3C-based data
Description:

TADbit is a complete Python library to deal with all steps to analyze, model, and explore 3C-based data. With TADbit the user can map FASTQ files to obtain raw interaction binned matrices (Hi-C like matrices), normalize and correct interaction matrices, identify and compare the so-called Topologically Associating Domains (TADs), build 3D models from the interaction matrices, and finally, extract structural properties from the models. TADbit is complemented by TADkit for visualizing 3D models.

python-bcbio-gff 0.7.1
Propagated dependencies: python-biopython@1.73 python-six@1.17.0
Channel: guix
Location: gnu/packages/bioinformatics.scm (gnu packages bioinformatics)
Home page: https://github.com/chapmanb/bcbb/tree/master/gff
Licenses: non-copyleft
Synopsis: Read and write GFF files with Biopython integration
Description:

This package lets you read and write files in Generic Feature Format (GFF) with Biopython integration.

Page: 123456789101112131415161718192021222324252627282930313233343536373839404142434445464748495051525354555657585960616263646566676869707172737475767778798081828384858687888990919293949596979899100101102103104105106107108109110111112113114115116117118119120121122123124125126127128129130131132133134135136137138139140141142143144145146147148149150151152153154155156157158159160161162163164165166167168169170171172173174175176177178179180181182183184185186187188189190191192193194195196197198199200201202203204205206207208209210211212213214215216217218219220221222223224225226227228229230231232233234235236237238239240241242243244245246247248249250251252253254255256257258259260261262263264265266267268269270271272273274275276277278279280281282283284285286287288289290291292293294295296297298299300301302303304305306307308309310311312313314315316317318319320321322323324325326327328329330331332333334335336337338339340341342343344345346347348349350351352353354355356357358359360361362363364365366367368369370371372373374375376377378379380381382383384385386387388389390391392393394395396397398399400401402403404405406407408409410411412413414415416417418419420421422423424425426427428429430431432433434435436437438439440441442443444445446447448449450451452453454455456457458459460461462463464465466467468469470471472473474475476477478479480481482483484485486487488489490491492493494495496497498499500501502503504505506507508509510511512513514515516517518519520521522523524525526527528529530531532533534535536537538539540541542543544545546547548549550551552553554555556557558559560561562563564565566567568569570571572573574575576577578579580581582583584585586587588589590591592593594595596597598599600601602603604605606607608609610611612613614615616617618619620621622623624625626627628629630631632633634635636637638639640641642643644645646647648649650651652653654655656657658659660661662663664665666667668669670671672673674675676677678679680681682683684685686687688689690691692693694695696697698699700701702703704705706707708709710711712713714715716717718719720721722723724725726727728729730731732733734735736737738739740741742743744745746747748749750751752753754755756757758759760761762763764765766767768769770771772773774775776777778779780781782783784785786787788789790791792793794795796797798799800801802803804805806807808809810811812813814815816817818819820821822823824825826827828829830831832833834835836837838839840841842843844845846847848849850851852853854855856857858859860861862863864865866867868869870871872873874875876877878879880881882883884885886887888889890891892893894895896897898899900901902903904905906907908909910911912913914915916917918919920921922923924925926927928929930931932933934935936937938939940941942943944945946947948949950951952953954955956957958959960961962963964965966967968969970971972973974975976977978979980981982983984985986987988989990991992993994995996997998999100010011002100310041005100610071008100910101011101210131014101510161017101810191020102110221023102410251026102710281029103010311032103310341035103610371038103910401041104210431044104510461047104810491050105110521053105410551056105710581059106010611062106310641065106610671068106910701071107210731074107510761077107810791080108110821083108410851086108710881089109010911092109310941095109610971098109911001101110211031104110511061107110811091110111111121113111411151116111711181119112011211122112311241125112611271128112911301131113211331134113511361137113811391140114111421143114411451146114711481149115011511152115311541155115611571158115911601161116211631164116511661167116811691170117111721173117411751176117711781179118011811182118311841185118611871188118911901191119211931194119511961197119811991200120112021203120412051206120712081209121012111212121312141215121612171218121912201221122212231224122512261227122812291230123112321233123412351236123712381239124012411242124312441245124612471248124912501251125212531254125512561257125812591260126112621263126412651266126712681269127012711272127312741275127612771278127912801281128212831284128512861287128812891290129112921293129412951296129712981299130013011302130313041305130613071308130913101311131213131314131513161317131813191320132113221323132413251326132713281329133013311332133313341335133613371338133913401341134213431344134513461347134813491350135113521353135413551356135713581359136013611362136313641365136613671368136913701371137213731374137513761377137813791380138113821383138413851386138713881389139013911392139313941395139613971398139914001401140214031404140514061407140814091410141114121413141414151416141714181419142014211422142314241425142614271428142914301431143214331434143514361437143814391440144114421443144414451446144714481449145014511452145314541455145614571458145914601461146214631464146514661467146814691470147114721473147414751476147714781479148014811482148314841485148614871488148914901491149214931494149514961497149814991500150115021503150415051506150715081509151015111512151315141515151615171518151915201521152215231524152515261527152815291530153115321533153415351536153715381539154015411542154315441545154615471548154915501551155215531554155515561557155815591560156115621563156415651566156715681569157015711572157315741575157615771578157915801581158215831584158515861587158815891590159115921593159415951596159715981599160016011602160316041605160616071608160916101611161216131614161516161617161816191620162116221623162416251626162716281629163016311632163316341635163616371638163916401641164216431644164516461647164816491650165116521653165416551656165716581659166016611662166316641665166616671668166916701671167216731674167516761677167816791680168116821683168416851686168716881689169016911692169316941695169616971698169917001701170217031704170517061707170817091710171117121713171417151716171717181719172017211722172317241725172617271728172917301731173217331734173517361737173817391740174117421743174417451746174717481749175017511752175317541755175617571758175917601761176217631764176517661767176817691770177117721773177417751776177717781779178017811782178317841785178617871788178917901791179217931794179517961797179817991800180118021803180418051806180718081809181018111812181318141815181618171818181918201821182218231824182518261827182818291830183118321833183418351836183718381839184018411842184318441845184618471848184918501851185218531854185518561857185818591860186118621863186418651866186718681869187018711872187318741875187618771878187918801881188218831884188518861887188818891890189118921893189418951896189718981899190019011902190319041905190619071908190919101911191219131914191519161917191819191920192119221923192419251926192719281929193019311932193319341935193619371938193919401941194219431944194519461947194819491950195119521953195419551956195719581959196019611962196319641965196619671968196919701971197219731974197519761977197819791980198119821983198419851986198719881989199019911992199319941995199619971998199920002001200220032004200520062007200820092010201120122013201420152016201720182019202020212022202320242025202620272028202920302031203220332034203520362037203820392040204120422043204420452046204720482049205020512052205320542055205620572058205920602061206220632064206520662067206820692070207120722073207420752076207720782079208020812082208320842085208620872088208920902091209220932094209520962097209820992100210121022103210421052106210721082109211021112112211321142115211621172118211921202121212221232124212521262127212821292130213121322133213421352136213721382139214021412142214321442145214621472148214921502151215221532154215521562157215821592160216121622163216421652166216721682169217021712172217321742175217621772178217921802181218221832184218521862187218821892190219121922193219421952196219721982199220022012202220322042205220622072208220922102211221222132214221522162217221822192220222122222223222422252226222722282229223022312232223322342235223622372238223922402241224222432244224522462247224822492250225122522253225422552256225722582259226022612262226322642265226622672268226922702271227222732274227522762277227822792280228122822283228422852286228722882289229022912292229322942295229622972298229923002301230223032304230523062307230823092310231123122313231423152316231723182319232023212322232323242325232623272328232923302331233223332334233523362337233823392340234123422343234423452346234723482349235023512352235323542355235623572358235923602361236223632364236523662367236823692370237123722373237423752376237723782379238023812382238323842385238623872388238923902391239223932394239523962397239823992400240124022403240424052406240724082409241024112412241324142415241624172418241924202421242224232424242524262427242824292430243124322433243424352436243724382439244024412442244324442445244624472448244924502451245224532454245524562457245824592460246124622463246424652466246724682469247024712472247324742475247624772478247924802481248224832484248524862487248824892490249124922493249424952496249724982499250025012502250325042505250625072508250925102511251225132514251525162517251825192520252125222523252425252526252725282529253025312532253325342535253625372538253925402541254225432544254525462547254825492550255125522553255425552556255725582559256025612562256325642565256625672568256925702571257225732574257525762577257825792580258125822583258425852586258725882589259025912592259325942595259625972598259926002601260226032604260526062607260826092610261126122613261426152616261726182619262026212622262326242625262626272628262926302631263226332634263526362637263826392640264126422643264426452646264726482649265026512652265326542655265626572658265926602661266226632664266526662667266826692670267126722673267426752676267726782679268026812682268326842685268626872688268926902691269226932694269526962697269826992700270127022703270427052706270727082709271027112712271327142715271627172718271927202721272227232724272527262727272827292730273127322733273427352736273727382739274027412742274327442745274627472748274927502751275227532754275527562757275827592760276127622763276427652766276727682769277027712772277327742775277627772778277927802781278227832784278527862787278827892790279127922793279427952796
Total results: 67086