Index index by Group index by Distribution index by Vendor index by creation date index by Name Mirrors Help Search

python313-biopython-1.85-bp160.1.3 RPM for x86_64

From OpenSuSE Leap 16.0 for x86_64

Name: python313-biopython Distribution: SUSE Linux Enterprise 16
Version: 1.85 Vendor: openSUSE
Release: bp160.1.3 Build date: Thu Mar 13 00:26:04 2025
Group: Unspecified Build host: reproducible
Size: 25486812 Source RPM: python-biopython-1.85-bp160.1.3.src.rpm
Packager: https://bugs.opensuse.org
Url: https://biopython.org/
Summary: Python Tools for Computational Molecular Biology
The Biopython Project is an international association of developers of freely
available Python tools for computational molecular biology.

Provides

Requires

License

BSD-3-Clause AND MIT

Changelog

* Wed Mar 12 2025 Friedrich Haubensak <hsk17@mail.de>
  - update to 1.85:
    * Some optimisation work was done for "Bio.SeqIO"
    * "Bio.motifs" now supports reading PFM from Cys2His2 Zinc Finger
      Proteins PWM Predictor
    * "Bio.motifs" now supports reverse complementing RNA motifs
      and correctly generating degenerate consensus sequences for
      RNA motifs
    * "Bio.motifs.minimal" now supports parsing RNA motifs and
      parsing motifs for which not all statistics are provided
    * "Bio.motifs.clusterbuster" now supports parsing GAP and WEIGHT
      parameters and can optionally write Cluster Buster motif files
      with floats instead of integers
  - drop patch py313-support.patch, now upstream
* Fri Nov 22 2024 Dirk Müller <dmueller@suse.com>
  - add py313-support.patch to fix build with python 3.13
* Thu Oct 10 2024 Dirk Müller <dmueller@suse.com>
  - update to 1.84:
    * The old parser stores information in a
      Bio.Blast.NCBIXML.Blast object, with attribute names based on
      plain-text Blast output. The new parser stores information in
      a Bio.Blast.Record object. This class follows the DTD that
      describes the XML in terms of attribute names and dictionary
      key names, class structure, and object types. This makes it
      easier to find the detailed description of each field in the
      NCBI Blast documentation.
    * The old parser stores alignment information directly as seen
      in the BLAST XML output, i.e. as strings with dashes to
      represent gaps. The new parser stores the alignment
      information as a Bio.Align.Alignment object, which can then
      be used to e.g. print the alignment in a different format.
* Sat Jan 20 2024 Dirk Müller <dmueller@suse.com>
  - update to 1.83:
    * This release reverts the removal of the .strand, .ref, and
      .ref_db attributes of the SeqFeature which was done without a
      deprecation period. They are again aliases for
      .location.strand etc, but trigger deprecation warnings.
* Wed Dec 27 2023 Dirk Müller <dmueller@suse.com>
  - update to 1.82:
    * The ``inplace`` argument of ``complement`` and
      ``reverse_complement`` in ``Bio.Seq`` now always default to
      ``False`` both for ``Seq`` and ``MutableSeq`` objects.
      To modify a ``MutableSeq`` in-place, use ``inplace=True``.
    * A new class ``CodonAligner`` was added to ``Bio.Align``. A
      ``CodonAligner`` object can align a nucleotide sequence to the
      amino acid sequence it encodes, using a dynamic programming
      algorithm modeled on ``PairwiseAligner`` to take frame shifts
      into account. The ``CodonAligner`` returns ``Alignment``
      objects.
    * By calling the new ``mapall`` method on an ``Alignment``
      object storing a multiple sequence alignment of amino acid
      sequences, with nucleotide-to-amino acid alignments generated
      by ``CodonAligner`` as the argument, a codon-by-codon
      multiple sequence alignment of nucleotide sequences can be
      obtained. The new submodule ``Bio.Align.analysis`` provides
      functions to estimate synonymous and nonsynonymous mutations
      and to perform the McDonald-Kreitman test on the codon
      multiple sequence alignments. Together, this provides the
      same functionality as the ``Bio.codonalign`` module, but uses
      the standard ``Alignment`` class, and does not rely on regular
      expression searching to align a nucleotide sequence to
      an amino acid sequence.
    * The ``hmmer3-text`` SearchIO format now also extracts the
      similarity string of the parsed alignments.
    * HMMER results with the full path to the hmmer executable in
      the banner are now parsed correctly.
    * We now have basic type hint annotations in various modules
      including ``Seq``, ``SeqRecord``, and ``SeqIO``.
    * Calling ``iter`` on a ``PairwiseAlignments`` object returned
      by a ``PairwiseAigner`` previously reset the iterator
      such that it will start from the first alignment when iterating.
    * The MMCIFParser now ignores '.' header values.
    * Calling ``set_angle()`` on a residue dihedral angle
      previously set only the specified angle, now the default
      behavior is to update overlapping angles as well.
    * Generating a structure with default internal coordinates,
      e.g. from a sequence with ``read_PIC_seq()``,  previously
      selected wrong default values in many cases.
    * Added ``make_extended()`` to set a chain to an extended beta
      strand conformation, as the default backbone values reflect
      the more popular alpha helix in most cases.
* Wed Feb 15 2023 Dirk Müller <dmueller@suse.com>
  - update to 1.81:
    * The API documentation and the `Biopython Tutorial and
      Cookbook` have been updated to better annotate use and
      application of the ``Bio.PDB.internal_coords`` module.
    * ``Bio.Phylo`` now supports ``Alignment`` and
      ``MultipleSeqAlignment`` objects as input.
    * Several improvements and bug fixes to the snapgene parser
* Wed Jan 04 2023 Dirk Müller <dmueller@suse.com>
  - update to 1.80:
    * This release of Biopython supports Python 3.7, 3.8, 3.9, 3.10, 3.11. It
      has also been tested on PyPy3.7 v7.3.5.
    * Functions ``read``, ``parse``, and ``write`` were added to ``Bio.Align``
      to read and write ``Alignment`` objects.
    * Because dict retains the item order by default since Python3.6, all
      instances of ``collections.OrderedDict`` have been replaced by either standard
      ``dict`` or where appropriate by ``collections.defaultsdict``.
    * The ``Bio.motifs.jaspar.db`` now returns ``tf_family`` and ``tf_class``
      as a string array since the JASPAR 2018 release.
    * The Local Composition Complexity functions from ``Bio.SeqUtils`` now
      uses base 4 log instead of 2 as stated in the original reference Konopka
      (2005), * Sequence Complexity and Composition.  https://doi.org/10.1038/npg.els.0005260
    * Append mode is now supported in ``Bio.bgzf`` (and a bug parsing blocked
      GZIP files with an internal empty block fixed).
    * The experimental warning was dropped from ``Bio.phenotype`` (which was
      new in Biopython 1.67).
    * Sequences now have a ``defined`` attribute that returns a boolean
      indicating if the underlying data is defined or not.
    * The ``Bio.PDB`` module now includes a structural alignment module, using
      the combinatorial extension algorithm of Shindyalov and Bourne, commonly
      known as CEAlign. The module allows for two structures to be aligned based solely
      on their 3D conformation, ie. in a sequence-independent manner. The method
      is particularly powerful when the structures shared a very low degree of
      sequence similarity. The new module is available in ``Bio.PDB.CEAligner`` with an
      interface similar to other 3D superimposition modules.
    * A new module ``Bio.PDB.qcprot`` implements the QCP superposition
      algorithm in pure Python, deprecating the existing C implementation. This leads to a
      slight performance improvement and to much better maintainability. The
      refactored ``qcprot.QCPSuperimposer`` class has small changes to its API, to better
      mirror that of ``Bio.PDB.Superimposer``.
    * The ``Bio.PDB.PDBList`` module now allows downloading biological
      assemblies, for one or more entries of the wwPDB.
    * In the ``Bio.Restriction`` module, each restriction enzyme now includes
      an `id` property giving the numerical identifier for the REBASE database
      identifier from which the enzyme object was created, and a `uri` property with a
      canonical `identifiers.org` link to the database, for use in linked-data
      representations.
    * Add new ``gc_fraction`` function in ``SeqUtils`` and marks ``GC`` for
      future deprecation.
    * Support for the old format (dating back to 2004) of the GN line in
      SwissProt files was dropped in ``Bio.SwissProt``.
    * Additionally, a number of small bugs and typos have been fixed with
      additions to the test suite.
* Sun Mar 27 2022 Dirk Müller <dmueller@suse.com>
  - update to 1.79:
    * This is intended to be our final release supporting Python 3.6. It also
    supports Python 3.7, 3.8 and 3.9, and has also been tested on PyPy3.6.1 v7.1.1.
    * Detailed list of changes see
    https://github.com/biopython/biopython/blob/biopython-179/NEWS.rst#1-june-2021-biopython-179
* Sat Feb 20 2021 andy great <andythe_great@pm.me>
  - Update to version 1.7.8.
    * The main change is that Bio.Alphabet is no longer used. In some
      cases you will now have to specify expected letters, molecule
      type (DNA, RNA, protein), or gap character explicitly.
    * Bio.SeqIO.parse() is faster with "fastq" format due to small
      improvements in the Bio.SeqIO.QualityIO module.
    * The SeqFeature object's .extract() method can now be used for
      trans-spliced locations via an optional dictionary of references.
    * As in recent releases, more of our code is now explicitly
      available under either our original "Biopython License Agreement",
      or the very similar but more commonly used "3-Clause BSD License".
      See the LICENSE.rst file for more details.
    * Additionally, a number of small bugs and typos have been fixed
      with additions to the test suite. There has been further work to
      follow the Python PEP8, PEP257 and best practice standard coding
      style, and all of the tests have been reformatted with the black
      tool to match the main code base.
  - Skip python36 because numpy no longer support it.
* Tue Nov 03 2020 Matej Cepl <mcepl@suse.com>
  - Remove ridiculously wide find commands in %prep, which break a lot
    (binary) files.
* Wed Jul 08 2020 Marketa Calabkova <mcalabkova@suse.com>
  - Update to version 1.77
    * **We have dropped support for Python 2 now.**
    * ``pairwise2`` now allows the input of parameters with keywords and returns the
      alignments as a list of ``namedtuples``.
    * The codon tables have been updated to NCBI genetic code table version 4.5,
      which adds Cephalodiscidae mitochondrial as table 33.
    * Updated ``Bio.Restriction`` to the January 2020 release of REBASE.
    * A major contribution by Rob Miller to ``Bio.PDB`` provides new methods to
      handle protein structure transformations using dihedral angles (internal
      coordinates). The new framework supports lossless interconversion between
      internal and cartesian coordinates, which, among other uses, simplifies the
      analysis and manipulation of coordinates of proteins structures.
    * ``PDBParser`` and ``PDBIO`` now support PQR format file parsing and input/
      output.
    * In addition to the mainstream ``x86_64`` aka ``AMD64`` CPU architecture, we
      now also test every contribution on the ``ARM64``, ``ppc64le``, and ``s390x``
      CPUs under Linux thanks to Travis CI. Further post-release testing done by
      Debian and other packagers and distributors of Biopython also covers these
      CPUs.
    * ``Bio.motifs.PositionSpecificScoringMatrix.search()`` method has been
      re-written: it now applies ``.calculate()`` to chunks of the sequence
      to maintain a low memory footprint for long sequences.
    * Additionally, a number of small bugs and typos have been fixed with further
      additions to the test suite. There has been further work to follow the Python
      PEP8, PEP257 and best practice standard coding style, and more of the code
      style has been reformatted with the ``black`` tool.
* Wed Nov 20 2019 Todd R <toddrme2178@gmail.com>
  - Update to version 1.75
    * The restriction enzyme list in Bio.Restriction has been updated to the August
      2019 release of REBASE.
    * ``Bio.SeqIO`` now supports reading and writing files in the native format of
      Christian Marck's DNA Strider program ("xdna" format, also used by Serial
      Cloner), as well as reading files in the native formats of GSL Biotech's
      SnapGene ("snapgene") and Textco Biosoftware's Gene Construction Kit ("gck").
    * ``Bio.AlignIO`` now supports GCG MSF multiple sequence alignments as the "msf"
      format (work funded by the National Marrow Donor Program).
    * The main ``Seq`` object now has string-like ``.index()`` and ``.rindex()``
      methods, matching the existing ``.find()`` and ``.rfind()`` implementations.
      The ``MutableSeq`` object retains its more list-like ``.index()`` behaviour.
    * The ``MMTFIO`` class has been added that allows writing of MMTF file format
      files from a Biopython structure object. ``MMTFIO`` has a similar interface to
      ``PDBIO`` and ``MMCIFIO``, including the use of a ``Select`` class to write
      out a specified selection. This final addition to read/write support for
      PDB/mmCIF/MMTF in Biopython allows conversion between all three file formats.
    * Values from mmCIF files are now read in as a list even when they consist of a
      single value. This change improves consistency and reduces the likelihood of
      making an error, but will require user code to be updated accordingly.
    * ``Bio.PDB`` has been updated to support parsing REMARK 99 header entries from
      PDB-style Astral files.
    * A new keyword parameter ``full_sequences`` was added to ``Bio.pairwise2``'s
      pretty print method ``format_alignment`` to restore the output of local
      alignments to the 'old' format (showing the whole sequences including the
      un-aligned parts instead of only showing the aligned parts).
    * A new function ``charge_at_pH(pH)`` has been added to ``ProtParam`` and
      ``IsoelectricPoint`` in ``Bio.SeqUtils``.
    * The ``PairwiseAligner`` in ``Bio.Align`` was extended to allow generalized
      pairwise alignments, i.e. alignments of any Python object, for example
      three-letter amino acid sequences, three-nucleotide codons, and arrays of
      integers.
    * A new module ``substitution_matrices`` was added to ``Bio.Align``, which
      includes an ``Array`` class that can be used as a substitution matrix. As
      the ``Array`` class is a subclass of a numpy array, mathematical operations
      can be applied to it directly, and C code that makes use of substitution
      matrices can directly access the numerical values stored in the substitution
      matrices. This module is intended as a replacement of ``Bio.SubsMat``,
      which is currently unmaintained.
    * As in recent releases, more of our code is now explicitly available under
      either our original "Biopython License Agreement", or the very similar but
      more commonly used "3-Clause BSD License".  See the ``LICENSE.rst`` file for
      more details.
    * Additionally, a number of small bugs and typos have been fixed with further
      additions to the test suite, and there has been further work to follow the
      Python PEP8, PEP257 and best practice standard coding style. We have also
      started to use the ``black`` Python code formatting tool.
* Tue Jul 23 2019 Todd R <toddrme2178@gmail.com>
  - Update to version 1.74
    * Our core sequence objects (``Seq``, ``UnknownSeq``, and ``MutableSeq``) now
      have a string-like ``.join()`` method.
    * The NCBI now allows longer accessions in the GenBank file LOCUS line, meaning
      the fields may not always follow the historical column based positions. We
      no longer give a warning when parsing these. We now allow writing such files
      (although with a warning as support for reading them is not yet widespread).
    * Support for the ``mysqlclient`` package, a fork of MySQLdb, has been added.
    * We now capture the IDcode field from PDB Header records.
    * ``Bio.pairwise2``'s pretty-print output from ``format_alignment`` has been
      optimized for local alignments: If they do not consist of the whole sequences,
      only the aligned section of the sequences are shown, together with the start
      positions of the sequences (in 1-based notation). Alignments of lists will now
      also be prettily printed.
    * ``Bio.SearchIO`` now supports parsing the text output of the HHsuite protein
      sequence search tool. The format name is ``hhsuite2-text`` and
      ``hhsuite3-text``, for versions 2 and 3 of HHsuite, respectively.
    * ``Bio.SearchIO`` HSP objects has a new attribute called ``output_index``. This
      attribute is meant for capturing the order by which the HSP were output in the
      parsed file and is set with a default value of -1 for all HSP objects. It is
      also used for sorting the output of ``QueryResult.hsps``.
    * ``Bio.SeqIO.AbiIO`` has been updated to preserve bytes value when parsing. The
      goal of this change is make the parser more robust by being able to extract
      string-values that are not utf-8-encoded. This affects all tag values, except
      for ID and description values, where they need to be extracted as strings
      to conform to the ``SeqRecord`` interface. In this case, the parser will
      attempt to decode using ``utf-8`` and fall back to the system encoding if that
      fails. This change affects Python 3 only.
    * ``Bio.motifs.mast`` has been updated to parse XML output files from MAST over
      the plain-text output file. The goal of this change is to parse a more
      structured data source with minimal loss of functionality upon future MAST
      releases. Class structure remains the same plus an additional attribute
      ``Record.strand_handling`` required for diagram parsing.
    * ``Bio.Entrez`` now automatically retries HTTP requests on failure. The
      maximum number of tries and the sleep between them can be configured by
      changing ``Bio.Entrez.max_tries`` and ``Bio.Entrez.sleep_between_tries``.
      (The defaults are 3 tries and 15 seconds, respectively.)
    * All tests using the older print-and-compare approach have been replaced by
      unittests following Python's standard testing framework.
    * On the documentation side, all the public modules, classes, methods and
      functions now have docstrings (built in help strings). Furthermore, the PDF
      version of the *Biopython Tutorial and Cookbook* now uses syntax coloring
      for code snippets.
    * Additionally, a number of small bugs and typos have been fixed with further
      additions to the test suite, and there has been further work to follow the
      Python PEP8, PEP257 and best practice standard coding style.
* Fri Jan 04 2019 Todd R <toddrme2178@gmail.com>
  - Update to version 1.73
    * As in recent releases, more of our code is now explicitly available under
      either our original "Biopython License Agreement", or the very similar but
      more commonly used "3-Clause BSD License".  See the ``LICENSE.rst`` file for
      more details.
    * The dictionary-like indexing in SeqIO and SearchIO will now explicitly preserve
      record order to match a behaviour change in the Python standard dict object.
      This means looping over the index will load the records in the on-disk order,
      which will be much faster (previously it would be effectively at random, based
      on the key hash sorting).
    * The "grant" matrix in Bio.SubsMat.MatrixInfo has been replaced as our original
      values taken from Gerhard Vogt's old webpages at EMBL Heidelberg were
      discovered to be in error. The new values have been transformed following
      Vogt's approach, taking the global maximum 215 minus the similarity scores
      from the original paper Grantham (1974), to give a distance measure.
    * Additionally, a number of small bugs and typos have been fixed with further
      additions to the test suite, and there has been further work to follow the
      Python PEP8, PEP257 and best practice standard coding style.
    * Double-quote characters in GenBank feature qualifier values in ``Bio.SeqIO``
      are now escaped as per the NCBI standard. Improperly escaped values trigger a
      warning on parsing.
    * There is a new command line wrapper for the BWA-MEM sequence mapper.
    * The string-based FASTA parsers in ``Bio.SeqIO.FastaIO`` have been optimised,
      which also speeds up parsing FASTA files using ``Bio.SeqIO.parse()``.
  - Update to version 1.72
    * Internal changes to Bio.SeqIO have sped up the SeqRecord .format method and
      SeqIO.write (especially when used in a for loop).
    * The MAF alignment indexing in Bio.AlignIO.MafIO has been updated to use
      inclusive end co-ordinates to better handle searches at end points. This
      will require you to rebuild any existing MAF index files.
    * In this release more of our code is now explicitly available under either our
      original "Biopython License Agreement", or the very similar but more commonly
      used "3-Clause BSD License".  See the ``LICENSE.rst`` file for more details.
    * The Entrez module now supports the NCBI API key. Also you can now set a custom
      directory for DTD and XSD files. This allows Entrez to be used in environments
      like AWS Lambda, which restricts write access to specific directories.
      Improved support for parsing NCBI Entrez XML files that use XSD schemas.
    * Internal changes to our C code mean that NumPy is no longer required at
      compile time - only at run time (and only for those modules which use NumPy).
    * Seq, UnknownSeq, MutableSeq and derived classes now support integer
      multiplication methods, matching native Python string methods.
    * A translate method has been added to Bio.SeqFeature that will extract a
      feature and translate it using the codon_start and transl_table qualifiers
      of the feature if they are present.
    * Bio.SearchIO is no longer considered experimental, and so it does not raise
      warnings anymore when imported.
    * A new pairwise sequence aligner is available in Bio.Align, as an alternative
      to the existing pairwise sequence aligner in Bio.pairwise2.
* Wed May 09 2018 toddrme2178@gmail.com
  - Update to version 1.71
    * Encoding issues have been fixed in several parsers when reading data files
      with non-ASCII characters, like accented letters in people's names. This would
      raise ``UnicodeDecodeError: 'ascii' codec can't decode byte ...`` under some
      system locale settings.
    * Bio.KEGG can now parse Gene files.
    * The multiple-sequence-alignment object used by Bio.AlignIO etc now supports
      a per-column annotation dictionary, useful for richly annotated alignments
      in the Stockholm/PFAM format.
    * The SeqRecord object now has a translate method, following the approach used
      for its existing reverse_complement method etc.
    * The output of function ``format_alignment`` in ``Bio.pairwise2`` for displaying
      a pairwise sequence alignment as text now indicates gaps and mis-matches.
    * Bio.SeqIO now supports reading and writing two-line-per-record FASTA files
      under the format name "fasta-2line", useful if you wish to work without
      line-wrapped sequences.
    * Bio.PDB now contains a writer for the mmCIF file format, which has been the
      standard PDB archive format since 2014. This allows structural objects to be
      written out and facilitates conversion between the PDB and mmCIF file formats.
    * Bio.Emboss.Applications has been updated to fix a wrong parameter in fuzznuc
      wrapper and include a new wrapper for fuzzpro.
    * The restriction enzyme list in Bio.Restriction has been updated to the
      November 2017 release of REBASE.
    * New codon tables 27-31 from NCBI (NCBI genetic code table version 4.2)
      were added to Bio.Data.CodonTable. Note that tables 27, 28 and 31 contain
      no dedicated stop codons; the stop codons in these codes have a context
      dependent encoding as either STOP or as amino acid.
    * In this release more of our code is now explicitly available under either our
      original "Biopython License Agreement", or the very similar but more commonly
      used "3-Clause BSD License".  See the ``LICENSE.rst`` file for more details.
    * IO functions such as ``SeqIO.parse`` now accept any objects which can be passed
      to the builtin ``open`` function. Specifically, this allows using
      ``pathlib.Path`` objects under Python 3.6 and newer, as per `PEP 519
      <https://www.python.org/dev/peps/pep-0519/>`_.
    * Bio.SearchIO can now parse InterProScan XML files.
    * For Python 3 compatibility, comparision operators for the entities within a
      Bio.PDB Structure object were implemented. These allow the comparison of
      models, chains, residues, and atoms with the common operators  (==, !=, >, ...)
      Comparisons are based on IDs and take the parents of the entity up to the
      model level into account. For consistent behaviour of all entities the operators
      for atoms were modified to also consider the parent IDs. NOTE: this represents a
      change in behaviour in respect to v1.70 for Atom comparisons. In order to mimic
      the behaviour of previous versions, comparison will have to be done for Atom IDs
      and alternative locations specifically.
    * Additionally, a number of small bugs and typos have been fixed with further
      additions to the test suite, and there has been further work to follow the
      Python PEP8, PEP257 and best practice standard coding style.
  - Update to version 1.70
    * Biopython now has a new logo, contributed by Patrick Kunzmann. Drawing on our
      original logo and the current Python logo, this shows a yellow and blue snake
      forming a double helix.
    * For installation Biopython now assumes ``setuptools`` is present, and takes
      advantage of this to declare we require NumPy at install time (except under
      Jython). This should help ensure ``pip install biopython`` works smoothly.
    * Bio.AlignIO now supports Mauve's eXtended Multi-FastA (XMFA) file format
      under the format name "mauve" (contributed by Eric Rasche).
    * Bio.ExPASy was updated to fix fetching PROSITE and PRODOC records, and return
      text-mode handles for use under Python 3.
    * Two new arguments for reading and writing blast-xml files have been added
      to the Bio.SearchIO functions (read/parse and write, respectively). They
      are 'use_raw_hit_ids' and 'use_raw_query_ids'. Check out the relevant
      SearchIO.BlastIO documentation for a complete description of what these
      arguments do.
    * Bio.motifs was updated to support changes in MEME v4.11.4 output.
    * The Bio.Seq sequence objects now have a ``.count_overlap()`` method to
      supplement the Python string like non-overlap based ``.count()`` method.
    * The Bio.SeqFeature location objects can now be compared for equality.
    * Bio.Phylo.draw_graphviz is now deprecated. We recommend using Bio.Phylo.draw
      instead, or another library or program if more advanced plotting functionality
      is needed.
    * In Bio.Phylo.TreeConstruction, the DistanceMatrix class (previously
      _DistanceMatrix) has a new method 'format_phylip' to write Phylip-compatible
      distance matrix files (contributed by Jordan Willis).
    * Additionally, a number of small bugs have been fixed with further additions
      to the test suite, and there has been further work to follow the Python PEP8,
      PEP257 and best practice standard coding style.
  - Use license tag
* Wed May 24 2017 toddrme2178@gmail.com
  - Implement single-spec version
  - Fix source URL.
  - updated to version 1.69
    * We now expect and take advantage of NumPy under PyPy, and compile most of the
      Biopython C code modules as well.
    * Bio.AlignIO now supports the UCSC Multiple Alignment Format (MAF) under the
      format name "maf", using new module Bio.AlignIO.MafIO which also offers
      indexed access to these potentially large files using SQLite3 (contributed by
      Andrew Sczesnak, with additional refinements from Adam Novak).
    * Bio.SearchIO.AbiIO has been extended to support parsing FSA files. The
      underlying format (ABIF) remains the same as AB1 files and so the string
      'abif' is the expected format argument in the main SeqIO functions. AbiIO
      determines whether the file is AB1 or FSA based on the presence of specific
      tags.
    * The Uniprot parser is now able to parse "submittedName" elements in XML files.
    * The NEXUS parser handling of internal node comments has been improved, which
      should help if working with tools like the BEAST TreeAnnotator. Slashes are
      now also allowed in identifiers.
    * New parser for ExPASy Cellosaurus, a cell line database, cell line catalogue,
      and cell line ontology (contributed by Steve Marshall).
    * For consistency the Bio.Seq module now offers a complement function (already
      available as a method on the Seq and MutableSeq objects).
    * The SeqFeature object's qualifiers is now an explicitly ordered dictionary
      (note that as of Python 3.6 the Python dict is ordered by default anyway).
      This helps reproduce GenBank/EMBL files on input/output.
    * The Bio.SeqIO UniProt-XML parser was updated to cope with features with
      unknown locations which can be found in mass spec data.
    * The Bio.SeqIO GenBank, EMBL, and IMGT parsers now record the molecule type
      from the LOCUS/ID line explicitly in the record.annotations dictionary.
      The Bio.SeqIO EMBL parser was updated to cope with more variants seen in
      patent data files, and the related IMGT parser was updated to cope with
      IPD-IMGT/HLA database files after release v3.16.0 when their ID line changed.
      The GenBank output now uses colon space to match current NCBI DBLINK lines.
    * The Bio.Affy package supports Affymetrix version 4 of the CEL file format,
      in addition to version 3.
    * The restriction enzyme list in Bio.Restriction has been updated to the
      February 2017 release of REBASE.
    * Bio.PDB.PDBList now can download PDBx/mmCif (new default), PDB (old default),
      PDBML/XML and mmtf format protein structures.  This is inline with the RCSB
      recommendation to use PDBx/mmCif and deprecate the PDB file format. Biopython
      already has support for parsing mmCif files.
    * Additionally, a number of small bugs have been fixed with further additions
      to the test suite, and there has been further work to follow the Python PEP8,
      PEP257 and best practice standard coding style.
* Thu Nov 17 2016 alinm.elena@gmail.com
  - updated to version 1.68
* Mon Dec 09 2013 toddrme2178@gmail.com
  - Update to version 1.63
    * 2to3 no longer needed for python 3
  - Added additional dependencies
* Thu Sep 19 2013 highwaystar.ru@gmail.com
  - upgrade to version 1.62
    * The translation functions will give a warning on any partial codons
    * Phylo module now supports the file formats NeXML and CDAO
    * New module Bio.UniProt adds parsers for the GAF, GPA and GPI
    formats from UniProt-GOA.
    * The BioSQL module is now supported in Jython.
    * Feature labels on circular GenomeDiagram figures now support
    the label_position argument (start, middle or end)
    * The code for parsing 3D structures in mmCIF files was updated
    to use the Python standard library's shlex module instead of C code
    using flex.
    * The Bio.Sequencing.Applications module now includes a BWA
    command line wrapper.
    * Bio.motifs supports JASPAR format files with multiple
    position-frequence matrices.
* Wed Feb 01 2012 saschpe@suse.de
  - Ran spec-cleaner
  - Set license to MIT (looks like it)
* Wed Jan 11 2012 toddrme2178@gmail.com
  - Cleaned up spec file
* Thu Sep 08 2011 alinm.elena@gmail.com
  - Initial commit

Files

/usr/lib64/python3.13/site-packages/Bio
/usr/lib64/python3.13/site-packages/Bio/Affy
/usr/lib64/python3.13/site-packages/Bio/Affy/CelFile.py
/usr/lib64/python3.13/site-packages/Bio/Affy/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Affy/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Affy/__pycache__/CelFile.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Affy/__pycache__/CelFile.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Affy/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Affy/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align
/usr/lib64/python3.13/site-packages/Bio/Align/AlignInfo.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/_ClustalOmega.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/_Clustalw.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/_Dialign.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/_MSAProbs.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/_Mafft.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/_Muscle.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/_Prank.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/_Probcons.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/_TCoffee.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_ClustalOmega.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_ClustalOmega.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Clustalw.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Clustalw.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Dialign.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Dialign.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_MSAProbs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_MSAProbs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Mafft.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Mafft.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Muscle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Muscle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Prank.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Prank.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Probcons.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_Probcons.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_TCoffee.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/_TCoffee.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/Applications/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/AlignInfo.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/AlignInfo.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/a2m.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/a2m.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/analysis.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/analysis.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/bed.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/bed.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/bigbed.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/bigbed.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/bigmaf.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/bigmaf.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/bigpsl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/bigpsl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/chain.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/chain.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/clustal.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/clustal.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/emboss.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/emboss.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/exonerate.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/exonerate.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/fasta.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/fasta.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/hhr.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/hhr.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/interfaces.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/interfaces.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/maf.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/maf.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/mauve.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/mauve.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/msf.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/msf.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/nexus.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/nexus.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/phylip.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/phylip.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/psl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/psl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/sam.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/sam.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/stockholm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/stockholm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/tabular.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/__pycache__/tabular.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/_aligncore.c
/usr/lib64/python3.13/site-packages/Bio/Align/_aligncore.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/Align/_codonaligner.c
/usr/lib64/python3.13/site-packages/Bio/Align/_codonaligner.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/Align/_pairwisealigner.c
/usr/lib64/python3.13/site-packages/Bio/Align/_pairwisealigner.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/Align/a2m.py
/usr/lib64/python3.13/site-packages/Bio/Align/analysis.py
/usr/lib64/python3.13/site-packages/Bio/Align/bed.py
/usr/lib64/python3.13/site-packages/Bio/Align/bigbed.py
/usr/lib64/python3.13/site-packages/Bio/Align/bigmaf.py
/usr/lib64/python3.13/site-packages/Bio/Align/bigpsl.py
/usr/lib64/python3.13/site-packages/Bio/Align/chain.py
/usr/lib64/python3.13/site-packages/Bio/Align/clustal.py
/usr/lib64/python3.13/site-packages/Bio/Align/emboss.py
/usr/lib64/python3.13/site-packages/Bio/Align/exonerate.py
/usr/lib64/python3.13/site-packages/Bio/Align/fasta.py
/usr/lib64/python3.13/site-packages/Bio/Align/hhr.py
/usr/lib64/python3.13/site-packages/Bio/Align/interfaces.py
/usr/lib64/python3.13/site-packages/Bio/Align/maf.py
/usr/lib64/python3.13/site-packages/Bio/Align/mauve.py
/usr/lib64/python3.13/site-packages/Bio/Align/msf.py
/usr/lib64/python3.13/site-packages/Bio/Align/nexus.py
/usr/lib64/python3.13/site-packages/Bio/Align/phylip.py
/usr/lib64/python3.13/site-packages/Bio/Align/psl.py
/usr/lib64/python3.13/site-packages/Bio/Align/sam.py
/usr/lib64/python3.13/site-packages/Bio/Align/stockholm.py
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BENNER22
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BENNER6
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BENNER74
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BLASTN
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BLASTP
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BLOSUM45
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BLOSUM50
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BLOSUM62
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BLOSUM80
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/BLOSUM90
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/DAYHOFF
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/FENG
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/GENETIC
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/GONNET1992
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/HOXD70
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/JOHNSON
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/JONES
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/LEVIN
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/MCLACHLAN
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/MDM78
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/MEGABLAST
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/NUC.4.4
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/PAM250
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/PAM30
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/PAM70
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/RAO
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/RISLER
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/SCHNEIDER
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/STR
/usr/lib64/python3.13/site-packages/Bio/Align/substitution_matrices/data/TRANS
/usr/lib64/python3.13/site-packages/Bio/Align/tabular.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO
/usr/lib64/python3.13/site-packages/Bio/AlignIO/ClustalIO.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/EmbossIO.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/FastaIO.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/Interfaces.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/MafIO.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/MauveIO.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/MsfIO.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/NexusIO.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/PhylipIO.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/StockholmIO.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__init__.py
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/ClustalIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/ClustalIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/EmbossIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/EmbossIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/FastaIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/FastaIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/Interfaces.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/Interfaces.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/MafIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/MafIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/MauveIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/MauveIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/MsfIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/MsfIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/NexusIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/NexusIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/PhylipIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/PhylipIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/StockholmIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/StockholmIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/AlignIO/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Alphabet
/usr/lib64/python3.13/site-packages/Bio/Alphabet/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Alphabet/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Alphabet/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Alphabet/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Application
/usr/lib64/python3.13/site-packages/Bio/Application/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Application/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Application/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Application/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast
/usr/lib64/python3.13/site-packages/Bio/Blast/Applications.py
/usr/lib64/python3.13/site-packages/Bio/Blast/NCBIWWW.py
/usr/lib64/python3.13/site-packages/Bio/Blast/NCBIXML.py
/usr/lib64/python3.13/site-packages/Bio/Blast/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/Applications.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/Applications.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/NCBIWWW.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/NCBIWWW.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/NCBIXML.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/NCBIXML.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/_parser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/_parser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/_writers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/__pycache__/_writers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Blast/_parser.py
/usr/lib64/python3.13/site-packages/Bio/Blast/_writers.py
/usr/lib64/python3.13/site-packages/Bio/CAPS
/usr/lib64/python3.13/site-packages/Bio/CAPS/__init__.py
/usr/lib64/python3.13/site-packages/Bio/CAPS/__pycache__
/usr/lib64/python3.13/site-packages/Bio/CAPS/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/CAPS/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Cluster
/usr/lib64/python3.13/site-packages/Bio/Cluster/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Cluster/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Cluster/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Cluster/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Cluster/_cluster.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/Cluster/cluster.c
/usr/lib64/python3.13/site-packages/Bio/Cluster/cluster.h
/usr/lib64/python3.13/site-packages/Bio/Cluster/clustermodule.c
/usr/lib64/python3.13/site-packages/Bio/Compass
/usr/lib64/python3.13/site-packages/Bio/Compass/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Compass/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Compass/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Compass/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Data
/usr/lib64/python3.13/site-packages/Bio/Data/CodonTable.py
/usr/lib64/python3.13/site-packages/Bio/Data/IUPACData.py
/usr/lib64/python3.13/site-packages/Bio/Data/PDBData.py
/usr/lib64/python3.13/site-packages/Bio/Data/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Data/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Data/__pycache__/CodonTable.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Data/__pycache__/CodonTable.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Data/__pycache__/IUPACData.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Data/__pycache__/IUPACData.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Data/__pycache__/PDBData.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Data/__pycache__/PDBData.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Data/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Data/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Emboss
/usr/lib64/python3.13/site-packages/Bio/Emboss/Applications.py
/usr/lib64/python3.13/site-packages/Bio/Emboss/Primer3.py
/usr/lib64/python3.13/site-packages/Bio/Emboss/PrimerSearch.py
/usr/lib64/python3.13/site-packages/Bio/Emboss/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Emboss/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Emboss/__pycache__/Applications.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Emboss/__pycache__/Applications.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Emboss/__pycache__/Primer3.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Emboss/__pycache__/Primer3.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Emboss/__pycache__/PrimerSearch.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Emboss/__pycache__/PrimerSearch.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Emboss/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Emboss/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Entrez
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/BITS-embedded-index2.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/BITS-question-answer2.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_0.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_0.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_1.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_1.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_2.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_2.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_3.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_3.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_4.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/Docsum_3_4.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/EMBL_General.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/EMBL_General.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/GenBank_General.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/GenBank_General.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/HomoloGene.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/HomoloGene.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/INSD_INSDSeq.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/INSD_INSDSeq.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-XHTMLtablesetup1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-ali-namespace1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-archivearticle1-3-mathml3.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-archivecustom-classes1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-archivecustom-mixes1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-archivecustom-models1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-archivecustom-modules1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-articlemeta1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-backmatter1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-chars1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-common-atts1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-common1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-default-classes1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-default-mixes1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-display1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-format1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-funding1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-journalmeta1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-link1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-list1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-math1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-mathml3-mathmlsetup1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-mathml3-modules1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-modules1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-nlmcitation1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-notat1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-para1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-phrase1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-references1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-related-object1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-section1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/JATS-xmlspecchars1-3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/MMDB.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/MMDB.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/MMDB_Chemical_graph.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/MMDB_Chemical_graph.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/MMDB_Features.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/MMDB_Features.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/MMDB_Structural_model.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/MMDB_Structural_model.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Access.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Access.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Biblio.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Biblio.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_BioSource.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_BioSource.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_BioTree.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_BioTree.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Blast4.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Blast4.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_BlastDL.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_BlastDL.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_BlastOutput.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_BlastOutput.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Cdd.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Cdd.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Cn3d.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Cn3d.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Entity.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Entrez2.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Entrez2.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Entrezgene.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Entrezgene.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_FeatDef.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_FeatDef.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_GBSeq.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_GBSeq.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Gene.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Gene.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_General.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_General.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_ID1Access.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_ID1Access.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_ID2Access.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_ID2Access.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_MedArchive.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_MedArchive.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Medlars.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Medlars.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Medline.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Medline.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Mim.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Mim.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Mime.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Mime.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_ObjPrt.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_ObjPrt.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Organism.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Organism.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_PCAssay.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_PCAssay.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_PCSubstance.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_PCSubstance.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Project.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Project.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Protein.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Protein.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Pub.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Pub.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_PubMed.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_PubMed.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_RNA.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_RNA.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Remap.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Remap.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Rsite.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Rsite.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_ScoreMat.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_ScoreMat.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_SeqCode.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_SeqCode.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_SeqTable.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_SeqTable.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seq_split.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seq_split.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqalign.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqalign.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqfeat.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqfeat.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqloc.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqloc.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqres.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqres.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqset.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Seqset.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Sequence.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Sequence.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Submit.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Submit.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Systems.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_TSeq.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_TSeq.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_TxInit.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_TxInit.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Variation.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_Variation.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NCBI_all.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NSE.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/NSE.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/OMSSA.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/OMSSA.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/PDB_General.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/PDB_General.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/PIR_General.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/PIR_General.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/PRF_General.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/PRF_General.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/SP_General.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/SP_General.mod.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/XHTMLtablesetup.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/archivearticle.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/archivecustom-classes.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/archivecustom-mixes.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/archivecustom-models.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/archivecustom-modules.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/articlemeta.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/backmatter.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/bookdoc_100301.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/bookdoc_110101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/bookdoc_120101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/bookdoc_130101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/bookdoc_140101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/bookdoc_150101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/chars.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/common.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/default-classes.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/default-mixes.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/display.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/eInfo_020511.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/eLink_090910.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/eLink_101123.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/ePost_020511.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/eSearch_020511.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/eSpell.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/eSummary_041029.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/egquery.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/einfo.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/elink.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/elink_020122.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/epost.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/esearch.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/esummary-v1.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/esummary_clinvar.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/esummary_gene.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/format.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/htmltable.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isoamsa.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isoamsb.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isoamsc.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isoamsn.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isoamso.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isoamsr.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isobox.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isocyr1.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isocyr2.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isodia.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isogrk1.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isogrk2.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isogrk3.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isogrk4.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isolat1.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isolat2.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isomfrk.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isomopf.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isomscr.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isonum.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isopub.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/isotech.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/journalmeta.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/link.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/list.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/math.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/mathml-in-pubmed.mod
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/mathml2-qname-1.mod
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/mathml2.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/mathml3-qname1.mod
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/mathml3.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/mathmlsetup.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/mmlalias.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/mmlextra.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/modules.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlm-articleset-2.0.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmcatalogrecordset_170601.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmcommon_011101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmcommon_080101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmcommon_090101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedline_011101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedline_080101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedline_090101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitation_011101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitation_080101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitation_090101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitationset_100101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitationset_100301.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitationset_110101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitationset_120101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitationset_130101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitationset_130501.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitationset_140101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmmedlinecitationset_150101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmserials_080101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmserials_100101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmsharedcatcit_080101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/nlmsharedcatcit_090101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/notat.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/para.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/phrase.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pmc-1.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_020114.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_080101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_090101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_100101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_100301.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_110101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_120101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_130101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_130501.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_140101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_150101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_180101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_180601.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/pubmed_190101.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/references.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/section.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/taxon.dtd
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/xhtml-inlstyle-1.mod
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/xhtml-table-1.mod
/usr/lib64/python3.13/site-packages/Bio/Entrez/DTDs/xmlspecchars.ent
/usr/lib64/python3.13/site-packages/Bio/Entrez/Parser.py
/usr/lib64/python3.13/site-packages/Bio/Entrez/XSDs
/usr/lib64/python3.13/site-packages/Bio/Entrez/XSDs/IPGReportSet.xsd
/usr/lib64/python3.13/site-packages/Bio/Entrez/XSDs/NCBI_BlastOutput2.mod.xsd
/usr/lib64/python3.13/site-packages/Bio/Entrez/XSDs/NCBI_BlastOutput2.xsd
/usr/lib64/python3.13/site-packages/Bio/Entrez/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Entrez/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Entrez/__pycache__/Parser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Entrez/__pycache__/Parser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Entrez/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Entrez/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy
/usr/lib64/python3.13/site-packages/Bio/ExPASy/Enzyme.py
/usr/lib64/python3.13/site-packages/Bio/ExPASy/Prodoc.py
/usr/lib64/python3.13/site-packages/Bio/ExPASy/Prosite.py
/usr/lib64/python3.13/site-packages/Bio/ExPASy/ScanProsite.py
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__init__.py
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/Enzyme.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/Enzyme.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/Prodoc.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/Prodoc.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/Prosite.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/Prosite.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/ScanProsite.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/ScanProsite.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/cellosaurus.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/__pycache__/cellosaurus.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/ExPASy/cellosaurus.py
/usr/lib64/python3.13/site-packages/Bio/File.py
/usr/lib64/python3.13/site-packages/Bio/GenBank
/usr/lib64/python3.13/site-packages/Bio/GenBank/Record.py
/usr/lib64/python3.13/site-packages/Bio/GenBank/Scanner.py
/usr/lib64/python3.13/site-packages/Bio/GenBank/__init__.py
/usr/lib64/python3.13/site-packages/Bio/GenBank/__pycache__
/usr/lib64/python3.13/site-packages/Bio/GenBank/__pycache__/Record.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/GenBank/__pycache__/Record.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/GenBank/__pycache__/Scanner.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/GenBank/__pycache__/Scanner.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/GenBank/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/GenBank/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/GenBank/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/GenBank/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/GenBank/utils.py
/usr/lib64/python3.13/site-packages/Bio/Geo
/usr/lib64/python3.13/site-packages/Bio/Geo/Record.py
/usr/lib64/python3.13/site-packages/Bio/Geo/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Geo/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Geo/__pycache__/Record.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Geo/__pycache__/Record.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Geo/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Geo/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics
/usr/lib64/python3.13/site-packages/Bio/Graphics/BasicChromosome.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/ColorSpiral.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/Comparative.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/DisplayRepresentation.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/Distribution.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_AbstractDrawer.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_CircularDrawer.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_Colors.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_CrossLink.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_Diagram.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_Feature.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_FeatureSet.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_Graph.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_GraphSet.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_LinearDrawer.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/_Track.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_AbstractDrawer.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_AbstractDrawer.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_CircularDrawer.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_CircularDrawer.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Colors.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Colors.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_CrossLink.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_CrossLink.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Diagram.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Diagram.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Feature.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Feature.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_FeatureSet.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_FeatureSet.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Graph.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Graph.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_GraphSet.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_GraphSet.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_LinearDrawer.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_LinearDrawer.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Track.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/_Track.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/GenomeDiagram/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/KGML_vis.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/BasicChromosome.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/BasicChromosome.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/ColorSpiral.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/ColorSpiral.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/Comparative.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/Comparative.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/DisplayRepresentation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/DisplayRepresentation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/Distribution.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/Distribution.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/KGML_vis.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/KGML_vis.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Graphics/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM
/usr/lib64/python3.13/site-packages/Bio/HMM/DynamicProgramming.py
/usr/lib64/python3.13/site-packages/Bio/HMM/MarkovModel.py
/usr/lib64/python3.13/site-packages/Bio/HMM/Trainer.py
/usr/lib64/python3.13/site-packages/Bio/HMM/Utilities.py
/usr/lib64/python3.13/site-packages/Bio/HMM/__init__.py
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/DynamicProgramming.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/DynamicProgramming.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/MarkovModel.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/MarkovModel.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/Trainer.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/Trainer.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/Utilities.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/Utilities.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/HMM/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG
/usr/lib64/python3.13/site-packages/Bio/KEGG/Compound
/usr/lib64/python3.13/site-packages/Bio/KEGG/Compound/__init__.py
/usr/lib64/python3.13/site-packages/Bio/KEGG/Compound/__pycache__
/usr/lib64/python3.13/site-packages/Bio/KEGG/Compound/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/Compound/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/Enzyme
/usr/lib64/python3.13/site-packages/Bio/KEGG/Enzyme/__init__.py
/usr/lib64/python3.13/site-packages/Bio/KEGG/Enzyme/__pycache__
/usr/lib64/python3.13/site-packages/Bio/KEGG/Enzyme/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/Enzyme/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/Gene
/usr/lib64/python3.13/site-packages/Bio/KEGG/Gene/__init__.py
/usr/lib64/python3.13/site-packages/Bio/KEGG/Gene/__pycache__
/usr/lib64/python3.13/site-packages/Bio/KEGG/Gene/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/Gene/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/KGML_parser.py
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/KGML_pathway.py
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/__init__.py
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/__pycache__
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/__pycache__/KGML_parser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/__pycache__/KGML_parser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/__pycache__/KGML_pathway.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/__pycache__/KGML_pathway.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/KGML/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/Map
/usr/lib64/python3.13/site-packages/Bio/KEGG/Map/__init__.py
/usr/lib64/python3.13/site-packages/Bio/KEGG/Map/__pycache__
/usr/lib64/python3.13/site-packages/Bio/KEGG/Map/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/Map/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/REST.py
/usr/lib64/python3.13/site-packages/Bio/KEGG/__init__.py
/usr/lib64/python3.13/site-packages/Bio/KEGG/__pycache__
/usr/lib64/python3.13/site-packages/Bio/KEGG/__pycache__/REST.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/__pycache__/REST.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/KEGG/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/LogisticRegression.py
/usr/lib64/python3.13/site-packages/Bio/MarkovModel.py
/usr/lib64/python3.13/site-packages/Bio/MaxEntropy.py
/usr/lib64/python3.13/site-packages/Bio/Medline
/usr/lib64/python3.13/site-packages/Bio/Medline/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Medline/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Medline/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Medline/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/NMR
/usr/lib64/python3.13/site-packages/Bio/NMR/NOEtools.py
/usr/lib64/python3.13/site-packages/Bio/NMR/__init__.py
/usr/lib64/python3.13/site-packages/Bio/NMR/__pycache__
/usr/lib64/python3.13/site-packages/Bio/NMR/__pycache__/NOEtools.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/NMR/__pycache__/NOEtools.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/NMR/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/NMR/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/NMR/__pycache__/xpktools.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/NMR/__pycache__/xpktools.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/NMR/xpktools.py
/usr/lib64/python3.13/site-packages/Bio/NaiveBayes.py
/usr/lib64/python3.13/site-packages/Bio/Nexus
/usr/lib64/python3.13/site-packages/Bio/Nexus/Nexus.py
/usr/lib64/python3.13/site-packages/Bio/Nexus/Nodes.py
/usr/lib64/python3.13/site-packages/Bio/Nexus/StandardData.py
/usr/lib64/python3.13/site-packages/Bio/Nexus/Trees.py
/usr/lib64/python3.13/site-packages/Bio/Nexus/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/Nexus.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/Nexus.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/Nodes.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/Nodes.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/StandardData.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/StandardData.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/Trees.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/Trees.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Nexus/cnexus.c
/usr/lib64/python3.13/site-packages/Bio/Nexus/cnexus.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/PDB
/usr/lib64/python3.13/site-packages/Bio/PDB/AbstractPropertyMap.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Atom.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Chain.py
/usr/lib64/python3.13/site-packages/Bio/PDB/DSSP.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Dice.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Entity.py
/usr/lib64/python3.13/site-packages/Bio/PDB/FragmentMapper.py
/usr/lib64/python3.13/site-packages/Bio/PDB/HSExposure.py
/usr/lib64/python3.13/site-packages/Bio/PDB/MMCIF2Dict.py
/usr/lib64/python3.13/site-packages/Bio/PDB/MMCIFParser.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Model.py
/usr/lib64/python3.13/site-packages/Bio/PDB/NACCESS.py
/usr/lib64/python3.13/site-packages/Bio/PDB/NeighborSearch.py
/usr/lib64/python3.13/site-packages/Bio/PDB/PDBExceptions.py
/usr/lib64/python3.13/site-packages/Bio/PDB/PDBIO.py
/usr/lib64/python3.13/site-packages/Bio/PDB/PDBList.py
/usr/lib64/python3.13/site-packages/Bio/PDB/PDBMLParser.py
/usr/lib64/python3.13/site-packages/Bio/PDB/PDBParser.py
/usr/lib64/python3.13/site-packages/Bio/PDB/PICIO.py
/usr/lib64/python3.13/site-packages/Bio/PDB/PSEA.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Polypeptide.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Residue.py
/usr/lib64/python3.13/site-packages/Bio/PDB/ResidueDepth.py
/usr/lib64/python3.13/site-packages/Bio/PDB/SASA.py
/usr/lib64/python3.13/site-packages/Bio/PDB/SCADIO.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Selection.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Structure.py
/usr/lib64/python3.13/site-packages/Bio/PDB/StructureAlignment.py
/usr/lib64/python3.13/site-packages/Bio/PDB/StructureBuilder.py
/usr/lib64/python3.13/site-packages/Bio/PDB/Superimposer.py
/usr/lib64/python3.13/site-packages/Bio/PDB/__init__.py
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/AbstractPropertyMap.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/AbstractPropertyMap.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Atom.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Atom.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Chain.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Chain.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/DSSP.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/DSSP.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Dice.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Dice.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Entity.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Entity.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/FragmentMapper.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/FragmentMapper.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/HSExposure.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/HSExposure.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/MMCIF2Dict.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/MMCIF2Dict.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/MMCIFParser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/MMCIFParser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Model.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Model.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/NACCESS.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/NACCESS.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/NeighborSearch.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/NeighborSearch.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBExceptions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBExceptions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBList.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBList.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBMLParser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBMLParser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBParser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PDBParser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PICIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PICIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PSEA.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/PSEA.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Polypeptide.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Polypeptide.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Residue.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Residue.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/ResidueDepth.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/ResidueDepth.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/SASA.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/SASA.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/SCADIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/SCADIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Selection.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Selection.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Structure.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Structure.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/StructureAlignment.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/StructureAlignment.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/StructureBuilder.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/StructureBuilder.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Superimposer.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/Superimposer.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/alphafold_db.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/alphafold_db.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/binary_cif.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/binary_cif.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/cealign.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/cealign.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/ic_data.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/ic_data.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/ic_rebuild.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/ic_rebuild.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/internal_coords.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/internal_coords.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/mmcifio.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/mmcifio.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/parse_pdb_header.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/parse_pdb_header.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/qcprot.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/qcprot.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/vectors.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/__pycache__/vectors.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/_bcif_helper.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/PDB/alphafold_db.py
/usr/lib64/python3.13/site-packages/Bio/PDB/bcifhelpermodule.c
/usr/lib64/python3.13/site-packages/Bio/PDB/binary_cif.py
/usr/lib64/python3.13/site-packages/Bio/PDB/ccealign.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/PDB/ccealignmodule.c
/usr/lib64/python3.13/site-packages/Bio/PDB/cealign.py
/usr/lib64/python3.13/site-packages/Bio/PDB/ic_data.py
/usr/lib64/python3.13/site-packages/Bio/PDB/ic_rebuild.py
/usr/lib64/python3.13/site-packages/Bio/PDB/internal_coords.py
/usr/lib64/python3.13/site-packages/Bio/PDB/kdtrees.c
/usr/lib64/python3.13/site-packages/Bio/PDB/kdtrees.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/PDB/mmcifio.py
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/DefaultParser.py
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/__init__.py
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/__pycache__
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/__pycache__/DefaultParser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/__pycache__/DefaultParser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/__pycache__/mmtfio.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/__pycache__/mmtfio.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PDB/mmtf/mmtfio.py
/usr/lib64/python3.13/site-packages/Bio/PDB/parse_pdb_header.py
/usr/lib64/python3.13/site-packages/Bio/PDB/qcprot.py
/usr/lib64/python3.13/site-packages/Bio/PDB/vectors.py
/usr/lib64/python3.13/site-packages/Bio/Pathway
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/Graph.py
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/MultiGraph.py
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/__pycache__/Graph.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/__pycache__/Graph.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/__pycache__/MultiGraph.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/__pycache__/MultiGraph.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Pathway/Rep/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Pathway/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Pathway/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Pathway/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Pathway/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/_Fasttree.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/_Phyml.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/_Raxml.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__pycache__/_Fasttree.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__pycache__/_Fasttree.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__pycache__/_Phyml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__pycache__/_Phyml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__pycache__/_Raxml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__pycache__/_Raxml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/Applications/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/BaseTree.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/CDAO.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/CDAOIO.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/Consensus.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/NeXML.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/NeXMLIO.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/Newick.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/NewickIO.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/NexusIO.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/_paml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/_paml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/_parse_baseml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/_parse_baseml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/_parse_codeml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/_parse_codeml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/_parse_yn00.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/_parse_yn00.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/baseml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/baseml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/chi2.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/chi2.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/codeml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/codeml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/yn00.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/__pycache__/yn00.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/_paml.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/_parse_baseml.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/_parse_codeml.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/_parse_yn00.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/baseml.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/chi2.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/codeml.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PAML/yn00.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PhyloXML.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/PhyloXMLIO.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/TreeConstruction.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/BaseTree.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/BaseTree.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/CDAO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/CDAO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/CDAOIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/CDAOIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/Consensus.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/Consensus.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/NeXML.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/NeXML.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/NeXMLIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/NeXMLIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/Newick.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/Newick.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/NewickIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/NewickIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/NexusIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/NexusIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/PhyloXML.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/PhyloXML.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/PhyloXMLIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/PhyloXMLIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/TreeConstruction.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/TreeConstruction.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/_cdao_owl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/_cdao_owl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/_io.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/_io.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/__pycache__/_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Phylo/_cdao_owl.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/_io.py
/usr/lib64/python3.13/site-packages/Bio/Phylo/_utils.py
/usr/lib64/python3.13/site-packages/Bio/PopGen
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/Controller.py
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/EasyController.py
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/FileParser.py
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/LargeFileParser.py
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__init__.py
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/Controller.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/Controller.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/EasyController.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/EasyController.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/FileParser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/FileParser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/LargeFileParser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/LargeFileParser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/GenePop/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/__init__.py
/usr/lib64/python3.13/site-packages/Bio/PopGen/__pycache__
/usr/lib64/python3.13/site-packages/Bio/PopGen/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/PopGen/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Restriction
/usr/lib64/python3.13/site-packages/Bio/Restriction/PrintFormat.py
/usr/lib64/python3.13/site-packages/Bio/Restriction/Restriction.py
/usr/lib64/python3.13/site-packages/Bio/Restriction/Restriction_Dictionary.py
/usr/lib64/python3.13/site-packages/Bio/Restriction/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Restriction/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Restriction/__pycache__/PrintFormat.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Restriction/__pycache__/PrintFormat.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Restriction/__pycache__/Restriction.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Restriction/__pycache__/Restriction.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Restriction/__pycache__/Restriction_Dictionary.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Restriction/__pycache__/Restriction_Dictionary.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Restriction/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Restriction/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP
/usr/lib64/python3.13/site-packages/Bio/SCOP/Cla.py
/usr/lib64/python3.13/site-packages/Bio/SCOP/Des.py
/usr/lib64/python3.13/site-packages/Bio/SCOP/Dom.py
/usr/lib64/python3.13/site-packages/Bio/SCOP/Hie.py
/usr/lib64/python3.13/site-packages/Bio/SCOP/Raf.py
/usr/lib64/python3.13/site-packages/Bio/SCOP/Residues.py
/usr/lib64/python3.13/site-packages/Bio/SCOP/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Cla.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Cla.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Des.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Des.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Dom.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Dom.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Hie.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Hie.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Raf.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Raf.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Residues.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/Residues.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SCOP/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SVDSuperimposer
/usr/lib64/python3.13/site-packages/Bio/SVDSuperimposer/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SVDSuperimposer/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SVDSuperimposer/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SVDSuperimposer/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/__pycache__/blast_tab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/__pycache__/blast_tab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/__pycache__/blast_xml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/__pycache__/blast_xml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/blast_tab.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlastIO/blast_xml.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/BlatIO.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/_base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/_base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/exonerate_cigar.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/exonerate_cigar.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/exonerate_text.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/exonerate_text.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/exonerate_vulgar.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/__pycache__/exonerate_vulgar.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/_base.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/exonerate_cigar.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/exonerate_text.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/ExonerateIO/exonerate_vulgar.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/FastaIO.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HHsuiteIO
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HHsuiteIO/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HHsuiteIO/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HHsuiteIO/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HHsuiteIO/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HHsuiteIO/__pycache__/hhsuite2_text.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HHsuiteIO/__pycache__/hhsuite2_text.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HHsuiteIO/hhsuite2_text.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/_base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/_base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/hmmer2_text.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/hmmer2_text.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/hmmer3_domtab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/hmmer3_domtab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/hmmer3_tab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/hmmer3_tab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/hmmer3_text.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/__pycache__/hmmer3_text.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/_base.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/hmmer2_text.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/hmmer3_domtab.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/hmmer3_tab.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/HmmerIO/hmmer3_text.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/InterproscanIO
/usr/lib64/python3.13/site-packages/Bio/SearchIO/InterproscanIO/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/InterproscanIO/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SearchIO/InterproscanIO/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/InterproscanIO/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/InterproscanIO/__pycache__/interproscan_xml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/InterproscanIO/__pycache__/interproscan_xml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/InterproscanIO/interproscan_xml.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/BlatIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/BlatIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/FastaIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/FastaIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/_index.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/_index.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/__pycache__/_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_index.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/_base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/_base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/hit.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/hit.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/hsp.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/hsp.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/query.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/__pycache__/query.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/_base.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/hit.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/hsp.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_model/query.py
/usr/lib64/python3.13/site-packages/Bio/SearchIO/_utils.py
/usr/lib64/python3.13/site-packages/Bio/Seq.py
/usr/lib64/python3.13/site-packages/Bio/SeqFeature.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO
/usr/lib64/python3.13/site-packages/Bio/SeqIO/AbiIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/AceIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/FastaIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/GckIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/GfaIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/IgIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/InsdcIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/Interfaces.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/NibIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/PdbIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/PhdIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/PirIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/QualityIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/SeqXmlIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/SffIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/SnapGeneIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/SwissIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/TabIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/TwoBitIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/UniprotIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/XdnaIO.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/AbiIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/AbiIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/AceIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/AceIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/FastaIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/FastaIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/GckIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/GckIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/GfaIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/GfaIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/IgIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/IgIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/InsdcIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/InsdcIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/Interfaces.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/Interfaces.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/NibIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/NibIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/PdbIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/PdbIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/PhdIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/PhdIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/PirIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/PirIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/QualityIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/QualityIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/SeqXmlIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/SeqXmlIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/SffIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/SffIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/SnapGeneIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/SnapGeneIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/SwissIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/SwissIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/TabIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/TabIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/TwoBitIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/TwoBitIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/UniprotIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/UniprotIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/XdnaIO.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/XdnaIO.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/_index.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/__pycache__/_index.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqIO/_index.py
/usr/lib64/python3.13/site-packages/Bio/SeqIO/_twoBitIO.c
/usr/lib64/python3.13/site-packages/Bio/SeqIO/_twoBitIO.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/SeqRecord.py
/usr/lib64/python3.13/site-packages/Bio/SeqUtils
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/CheckSum.py
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/IsoelectricPoint.py
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/MeltingTemp.py
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/ProtParam.py
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/ProtParamData.py
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/CheckSum.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/CheckSum.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/IsoelectricPoint.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/IsoelectricPoint.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/MeltingTemp.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/MeltingTemp.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/ProtParam.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/ProtParam.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/ProtParamData.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/ProtParamData.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/lcc.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/__pycache__/lcc.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SeqUtils/lcc.py
/usr/lib64/python3.13/site-packages/Bio/Sequencing
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Ace.py
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/_Novoalign.py
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__pycache__/_Novoalign.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__pycache__/_Novoalign.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__pycache__/_bwa.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__pycache__/_bwa.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__pycache__/_samtools.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/__pycache__/_samtools.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/_bwa.py
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Applications/_samtools.py
/usr/lib64/python3.13/site-packages/Bio/Sequencing/Phd.py
/usr/lib64/python3.13/site-packages/Bio/Sequencing/__init__.py
/usr/lib64/python3.13/site-packages/Bio/Sequencing/__pycache__
/usr/lib64/python3.13/site-packages/Bio/Sequencing/__pycache__/Ace.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/__pycache__/Ace.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/__pycache__/Phd.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/__pycache__/Phd.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/Sequencing/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SwissProt
/usr/lib64/python3.13/site-packages/Bio/SwissProt/KeyWList.py
/usr/lib64/python3.13/site-packages/Bio/SwissProt/__init__.py
/usr/lib64/python3.13/site-packages/Bio/SwissProt/__pycache__
/usr/lib64/python3.13/site-packages/Bio/SwissProt/__pycache__/KeyWList.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SwissProt/__pycache__/KeyWList.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/SwissProt/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/SwissProt/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/TogoWS
/usr/lib64/python3.13/site-packages/Bio/TogoWS/__init__.py
/usr/lib64/python3.13/site-packages/Bio/TogoWS/__pycache__
/usr/lib64/python3.13/site-packages/Bio/TogoWS/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/TogoWS/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/UniGene
/usr/lib64/python3.13/site-packages/Bio/UniGene/__init__.py
/usr/lib64/python3.13/site-packages/Bio/UniGene/__pycache__
/usr/lib64/python3.13/site-packages/Bio/UniGene/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/UniGene/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/UniProt
/usr/lib64/python3.13/site-packages/Bio/UniProt/GOA.py
/usr/lib64/python3.13/site-packages/Bio/UniProt/__init__.py
/usr/lib64/python3.13/site-packages/Bio/UniProt/__pycache__
/usr/lib64/python3.13/site-packages/Bio/UniProt/__pycache__/GOA.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/UniProt/__pycache__/GOA.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/UniProt/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/UniProt/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__init__.py
/usr/lib64/python3.13/site-packages/Bio/__pycache__
/usr/lib64/python3.13/site-packages/Bio/__pycache__/File.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/File.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/LogisticRegression.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/LogisticRegression.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/MarkovModel.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/MarkovModel.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/MaxEntropy.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/MaxEntropy.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/NaiveBayes.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/NaiveBayes.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/Seq.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/Seq.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/SeqFeature.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/SeqFeature.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/SeqRecord.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/SeqRecord.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/bgzf.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/bgzf.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/kNN.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/kNN.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/pairwise2.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/__pycache__/pairwise2.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/_utils.py
/usr/lib64/python3.13/site-packages/Bio/bgzf.py
/usr/lib64/python3.13/site-packages/Bio/codonalign
/usr/lib64/python3.13/site-packages/Bio/codonalign/__init__.py
/usr/lib64/python3.13/site-packages/Bio/codonalign/__pycache__
/usr/lib64/python3.13/site-packages/Bio/codonalign/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/codonalign/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/codonalign/__pycache__/codonalignment.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/codonalign/__pycache__/codonalignment.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/codonalign/__pycache__/codonseq.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/codonalign/__pycache__/codonseq.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/codonalign/codonalignment.py
/usr/lib64/python3.13/site-packages/Bio/codonalign/codonseq.py
/usr/lib64/python3.13/site-packages/Bio/cpairwise2.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/cpairwise2module.c
/usr/lib64/python3.13/site-packages/Bio/kNN.py
/usr/lib64/python3.13/site-packages/Bio/motifs
/usr/lib64/python3.13/site-packages/Bio/motifs/__init__.py
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/alignace.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/alignace.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/clusterbuster.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/clusterbuster.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/mast.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/mast.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/matrix.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/matrix.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/meme.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/meme.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/minimal.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/minimal.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/pfm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/pfm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/thresholds.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/thresholds.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/transfac.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/transfac.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/xms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/__pycache__/xms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/_pwm.c
/usr/lib64/python3.13/site-packages/Bio/motifs/_pwm.cpython-313-x86_64-linux-gnu.so
/usr/lib64/python3.13/site-packages/Bio/motifs/alignace.py
/usr/lib64/python3.13/site-packages/Bio/motifs/applications
/usr/lib64/python3.13/site-packages/Bio/motifs/applications/__init__.py
/usr/lib64/python3.13/site-packages/Bio/motifs/applications/__pycache__
/usr/lib64/python3.13/site-packages/Bio/motifs/applications/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/applications/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/applications/__pycache__/_xxmotif.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/applications/__pycache__/_xxmotif.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/applications/_xxmotif.py
/usr/lib64/python3.13/site-packages/Bio/motifs/clusterbuster.py
/usr/lib64/python3.13/site-packages/Bio/motifs/jaspar
/usr/lib64/python3.13/site-packages/Bio/motifs/jaspar/__init__.py
/usr/lib64/python3.13/site-packages/Bio/motifs/jaspar/__pycache__
/usr/lib64/python3.13/site-packages/Bio/motifs/jaspar/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/jaspar/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/jaspar/__pycache__/db.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/jaspar/__pycache__/db.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/motifs/jaspar/db.py
/usr/lib64/python3.13/site-packages/Bio/motifs/mast.py
/usr/lib64/python3.13/site-packages/Bio/motifs/matrix.py
/usr/lib64/python3.13/site-packages/Bio/motifs/meme.py
/usr/lib64/python3.13/site-packages/Bio/motifs/minimal.py
/usr/lib64/python3.13/site-packages/Bio/motifs/pfm.py
/usr/lib64/python3.13/site-packages/Bio/motifs/thresholds.py
/usr/lib64/python3.13/site-packages/Bio/motifs/transfac.py
/usr/lib64/python3.13/site-packages/Bio/motifs/xms.py
/usr/lib64/python3.13/site-packages/Bio/pairwise2.py
/usr/lib64/python3.13/site-packages/Bio/phenotype
/usr/lib64/python3.13/site-packages/Bio/phenotype/__init__.py
/usr/lib64/python3.13/site-packages/Bio/phenotype/__pycache__
/usr/lib64/python3.13/site-packages/Bio/phenotype/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/phenotype/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/phenotype/__pycache__/phen_micro.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/phenotype/__pycache__/phen_micro.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/phenotype/__pycache__/pm_fitting.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/Bio/phenotype/__pycache__/pm_fitting.cpython-313.pyc
/usr/lib64/python3.13/site-packages/Bio/phenotype/phen_micro.py
/usr/lib64/python3.13/site-packages/Bio/phenotype/pm_fitting.py
/usr/lib64/python3.13/site-packages/Bio/py.typed
/usr/lib64/python3.13/site-packages/BioSQL
/usr/lib64/python3.13/site-packages/BioSQL/BioSeq.py
/usr/lib64/python3.13/site-packages/BioSQL/BioSeqDatabase.py
/usr/lib64/python3.13/site-packages/BioSQL/DBUtils.py
/usr/lib64/python3.13/site-packages/BioSQL/Loader.py
/usr/lib64/python3.13/site-packages/BioSQL/__init__.py
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/BioSeq.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/BioSeq.cpython-313.pyc
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/BioSeqDatabase.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/BioSeqDatabase.cpython-313.pyc
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/DBUtils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/DBUtils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/Loader.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/Loader.cpython-313.pyc
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/BioSQL/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/BioSQL/py.typed
/usr/lib64/python3.13/site-packages/biopython-1.85-py3.13.egg-info
/usr/lib64/python3.13/site-packages/biopython-1.85-py3.13.egg-info/PKG-INFO
/usr/lib64/python3.13/site-packages/biopython-1.85-py3.13.egg-info/SOURCES.txt
/usr/lib64/python3.13/site-packages/biopython-1.85-py3.13.egg-info/dependency_links.txt
/usr/lib64/python3.13/site-packages/biopython-1.85-py3.13.egg-info/requires.txt
/usr/lib64/python3.13/site-packages/biopython-1.85-py3.13.egg-info/top_level.txt
/usr/share/doc/packages/python313-biopython
/usr/share/doc/packages/python313-biopython/CONTRIB.rst
/usr/share/doc/packages/python313-biopython/DEPRECATED.rst
/usr/share/doc/packages/python313-biopython/Doc
/usr/share/doc/packages/python313-biopython/Doc/Makefile
/usr/share/doc/packages/python313-biopython/Doc/_templates
/usr/share/doc/packages/python313-biopython/Doc/_templates/versions.html
/usr/share/doc/packages/python313-biopython/Doc/biopdb_faq.tex
/usr/share/doc/packages/python313-biopython/Doc/conf.py
/usr/share/doc/packages/python313-biopython/Doc/cookbook
/usr/share/doc/packages/python313-biopython/Doc/cookbook/Restriction
/usr/share/doc/packages/python313-biopython/Doc/cookbook/Restriction/Restriction.html
/usr/share/doc/packages/python313-biopython/Doc/doc.tex
/usr/share/doc/packages/python313-biopython/Doc/images
/usr/share/doc/packages/python313-biopython/Doc/images/1a8o-ca-plot.png
/usr/share/doc/packages/python313-biopython/Doc/images/BlastRecord.png
/usr/share/doc/packages/python313-biopython/Doc/images/GD_sigil_arrow_heads.png
/usr/share/doc/packages/python313-biopython/Doc/images/GD_sigil_arrow_shafts.png
/usr/share/doc/packages/python313-biopython/Doc/images/GD_sigil_labels.png
/usr/share/doc/packages/python313-biopython/Doc/images/GD_sigils.png
/usr/share/doc/packages/python313-biopython/Doc/images/PSIBlastRecord.png
/usr/share/doc/packages/python313-biopython/Doc/images/SRR001666.png
/usr/share/doc/packages/python313-biopython/Doc/images/biopython_logo.pdf
/usr/share/doc/packages/python313-biopython/Doc/images/biopython_logo.svg
/usr/share/doc/packages/python313-biopython/Doc/images/biopython_logo_l.png
/usr/share/doc/packages/python313-biopython/Doc/images/biopython_logo_m.png
/usr/share/doc/packages/python313-biopython/Doc/images/biopython_logo_old.jpg
/usr/share/doc/packages/python313-biopython/Doc/images/biopython_logo_s.png
/usr/share/doc/packages/python313-biopython/Doc/images/biopython_logo_white.png
/usr/share/doc/packages/python313-biopython/Doc/images/biopython_logo_xs.png
/usr/share/doc/packages/python313-biopython/Doc/images/dot_plot.png
/usr/share/doc/packages/python313-biopython/Doc/images/dot_plot_scatter.png
/usr/share/doc/packages/python313-biopython/Doc/images/gc_plot.png
/usr/share/doc/packages/python313-biopython/Doc/images/hist_plot.png
/usr/share/doc/packages/python313-biopython/Doc/images/phe-pairs-3pbl.png
/usr/share/doc/packages/python313-biopython/Doc/images/phylo-apaf-zoom.png
/usr/share/doc/packages/python313-biopython/Doc/images/phylo-apaf.png
/usr/share/doc/packages/python313-biopython/Doc/images/phylo-color-draw.png
/usr/share/doc/packages/python313-biopython/Doc/images/phylo-color.png
/usr/share/doc/packages/python313-biopython/Doc/images/phylo-dot.png
/usr/share/doc/packages/python313-biopython/Doc/images/phylo-draw-example.png
/usr/share/doc/packages/python313-biopython/Doc/images/phylo-rooted.png
/usr/share/doc/packages/python313-biopython/Doc/images/phylo-simple-draw.png
/usr/share/doc/packages/python313-biopython/Doc/images/plasmid_circular.png
/usr/share/doc/packages/python313-biopython/Doc/images/plasmid_circular_nice.png
/usr/share/doc/packages/python313-biopython/Doc/images/plasmid_linear.png
/usr/share/doc/packages/python313-biopython/Doc/images/plasmid_linear_nice.png
/usr/share/doc/packages/python313-biopython/Doc/images/simple_chrom.pdf
/usr/share/doc/packages/python313-biopython/Doc/images/simple_chrom.png
/usr/share/doc/packages/python313-biopython/Doc/images/smcra.png
/usr/share/doc/packages/python313-biopython/Doc/images/tRNA_chrom.pdf
/usr/share/doc/packages/python313-biopython/Doc/images/tRNA_chrom.png
/usr/share/doc/packages/python313-biopython/Doc/images/three_track_cl.png
/usr/share/doc/packages/python313-biopython/Doc/images/three_track_cl2a.png
/usr/share/doc/packages/python313-biopython/Doc/images/three_track_simple.png
/usr/share/doc/packages/python313-biopython/NEWS.rst
/usr/share/doc/packages/python313-biopython/README.rst
/usr/share/doc/packages/python313-biopython/examples
/usr/share/doc/packages/python313-biopython/examples/ACT_example.py
/usr/share/doc/packages/python313-biopython/examples/PF05371_seed.sth
/usr/share/doc/packages/python313-biopython/examples/Plates.csv
/usr/share/doc/packages/python313-biopython/examples/Proux_et_al_2002_Figure_6.py
/usr/share/doc/packages/python313-biopython/examples/alpha.faa
/usr/share/doc/packages/python313-biopython/examples/beta.faa
/usr/share/doc/packages/python313-biopython/examples/clustal_run.py
/usr/share/doc/packages/python313-biopython/examples/ec_5.4.2.2.txt
/usr/share/doc/packages/python313-biopython/examples/fasta_dictionary.py
/usr/share/doc/packages/python313-biopython/examples/fasta_iterator.py
/usr/share/doc/packages/python313-biopython/examples/ls_orchid.fasta
/usr/share/doc/packages/python313-biopython/examples/ls_orchid.gbk
/usr/share/doc/packages/python313-biopython/examples/ls_orchid.gbk.bgz
/usr/share/doc/packages/python313-biopython/examples/ls_orchid.gbk.bz2
/usr/share/doc/packages/python313-biopython/examples/ls_orchid.gbk.gz
/usr/share/doc/packages/python313-biopython/examples/m_cold.fasta
/usr/share/doc/packages/python313-biopython/examples/my_blast.xml
/usr/share/doc/packages/python313-biopython/examples/my_blat.psl
/usr/share/doc/packages/python313-biopython/examples/nmr
/usr/share/doc/packages/python313-biopython/examples/nmr/noed.xpk
/usr/share/doc/packages/python313-biopython/examples/nmr/simplepredict.py
/usr/share/doc/packages/python313-biopython/examples/opuntia.aln
/usr/share/doc/packages/python313-biopython/examples/opuntia.dnd
/usr/share/doc/packages/python313-biopython/examples/opuntia.fasta
/usr/share/doc/packages/python313-biopython/examples/simple.dnd
/usr/share/doc/packages/python313-biopython/examples/swissprot.py
/usr/share/doc/packages/python313-biopython/examples/www_blast.py
/usr/share/licenses/python313-biopython
/usr/share/licenses/python313-biopython/LICENSE.rst


Generated by rpm2html 1.8.1

Fabrice Bellet, Tue Jun 3 00:35:07 2025