VirtualMicrobes Evolutionary Simulator documentation

Contents:

Overview

The VirtualMicrobes software package is a simulator of Virtual Microbe evolution. Virtual Microbes live in spatial environment where they compete for resources. In order to grow and divide they express their metabolic and regulatory genes to generate biomass. Mutations in their genome change the rates of metabolic reactions and gene expression levels enabling them to become better adapted over time.

Motivation

This software is being developed as part of the research in the EvoEvo project. The goal of the EvoEvo project is to understand how evolution can modify its own course. Mutations in the genome of an organism change the phenotype, thereby allowing adaptation to the environmental circumstances. Yet, how genotypic changes are translated to phenotypic changes, is itself an evolved property of species. Changing this genotype to phenotype mapping may make organisms more or less robust to mutations with respect to their functioning. Moreover, some structures of this mapping may make it more likely for random mutations to have large phenotypic effects, increasing the chance that a novel adaptive phenotype will be discovered. The goal of the VirtualMicrobes project is to study the in silico evolution of genome structure and of the genotype to phenotype mapping.

Features

  • population of individuals
  • spatial environment
  • parameterized metabolic reaction space
  • gene regulatory interaction network
  • cell growth dynamics
  • spatially extended genome
  • genome and gene scale mutations
  • lineage tracing

Installing

Before installing VirtualMicrobes, you need to have setuptools installed.

Quick install

Get VirtualMicrobes from the Python Package Index at http://pypi.python.org/pypi/VirtualMicrobes

or install it with

pip install VirtualMicrobes

and an attempt will be made to find and install an appropriate version that matches your operating system and Python version.

The project can be cloned from bitbucket with:

git clone https://thocu@bitbucket.org/thocu/virtualmicrobes.git

Requirements

Installing the project via pip, the required packages will be checked against your installation and installed if necessary.

Python

To use VirtualMicrobes you need Python 2.7

ete3

This is a package for drawing and manipulating phylogenetic trees. It is used to keep track of phylogenetic relationships between Virtual Microbes.

ete3 has its own dependency on pyqt.

Matplotlib

Used for generating various plots during the simulation.

Gnu Scientific Library

Other

  • networkx
  • attrdict
  • blessings
  • networkx
  • pandas
  • psutil
  • errand_boy
  • orderedset
  • pyparsing
  • setproctitle
  • sortedcontainers
  • mpl

Optional packages

Cython and CythonGSL

The package includes a few C Extension modules, originally written in the Cython language. If during the install both Cython and the CythonGSL package are detected, the extensions will be build from the original .pyx sources. Otherwise, the included pre-generated .c files will be used to build the extension.

Reference

VirtualMicrobes package

Subpackages

VirtualMicrobes.Tree package
Submodules
VirtualMicrobes.Tree.PhyloTree module
class VirtualMicrobes.Tree.PhyloTree.PhyloNode(val, time)[source]

Bases: object

Version:
Author:
add_root(root_node)[source]
children
connect_phylo_offspring(offspring)[source]
dist_to_parent(parent)[source]
excise()[source]

remove references to this node from other tree nodes and reconnect remaining nodes.

has_root()[source]
id = 0
inherit_root(node)[source]
is_leaf

is this a leaf of the tree

iter_prepostorder(is_leaf_fn=None)[source]

Iterate over all nodes in a tree yielding every node in both pre and post order. Each iteration returns a postorder flag (True if node is being visited in postorder) and a node instance.

max_node_depth = 0
newick_id

id tag used in new hampshire (newick) tree format

nh_format_nr(_format='newick', formatter=<function nh_branch>)[source]

Format a newick string non-recursively, including internal nodes. (ete3, ape and iTol compatible!) NOTE: iTol doesn’t like trees without leafs, so if you have a nh tree like (((A)B)C)D it will start complaining Add a comma to the deepest leaf to fix this, and delete it via iTol if you really want it. (((A,)B)C)D :) :param with_leafs: :param _format: :param formatter:

nhx_features

additional node features used in the ‘extended’ newick format (nhx)

parents
push_onto_internal_child(child)[source]

makes this node an internal parent node of child :param child:

push_up_root()[source]

Iteratively push up the root to the internal_parent_node.

remove_root_stem()[source]
class VirtualMicrobes.Tree.PhyloTree.PhyloTree(supertree=False)[source]

Bases: object

Primary use is a phylogenetic tree, representing reproduction/speciation events at particular points in time. Because generations are overlapping, a parent may have offspring at various time points. Therefore Nodes are not strictly parents, but rather, parent-reproduction-time tuples.

class SuperNode[source]

Bases: object

add_leaf(leaf)[source]
add_node(phylo_unit, time)[source]
add_phylo_history(phylo_unit)[source]
annotate_leafs(ete_tree_struct, leaf)[source]

Annotate leaf labels

annotate_phylo_units_feature(ete_tree_struct, phylo_units, feature_name)[source]
check_ete_mapping(leafs=False)[source]
class_version = '1.0'
clear()[source]
coalescent()[source]

Find coalescent node and depth in the tree.

Returns:(class
Return type:Tree.PhyloTree.PhyloNode, time) : LCA, depth
connect_internal_node(int_node)[source]

Connect internal node ‘int_node’ with nodes above and below it on its own branch (representing births and/or death in this phylogenetic unit’s life history branch)

Parameters:int_node – newly made internal node that should get connected up

and down in the tree.

connect_leaf(leaf_node)[source]
connect_phylo_parent_child(phylo_parent_node, phylo_child_node)[source]
create_leaf(phylo_unit)[source]
create_root_stem(phylo_root)[source]
create_stems(phylo_unit)[source]
delete_empty_phylo_stems()[source]
delete_node(tree_node)[source]
delete_phylo_hist(phylo_unit)[source]

Remove the branch representing the phylogenetic unit and disconnect it from all sub-branches (children) in the tree.

Parameters:phylo_unit
distances(ete_tree, nodes)[source]

Pairwise distances between all nodes.

Parameters:
  • ete_tree (ete3.TreeNode) – ete tree root node
  • nodes (sequence of (phylo_node, ete_node) pairs) –
Returns:

  • tree_dist is phylogenetic distance.
  • top_dist is topological distance

Return type:

sequence of (phylo_node1, phylo_node2, tree_dist, top_dist)

ete_annotate_tree(ete_tree_struct, features=[], func_features={}, ete_root=None)[source]

Annotate the phylogenetic tree with cell data for tree plotting.

Assumes that the ete_tree has been constructed/updated. Creates a dictionary of feature dictionaries, keyed by the cells in the tree. Attaches the feature dictionaries to nodes in the ete_tree (annotate_ete_tree). Transforms some data to cummulative data along the branches of the tree. Optionally, prunes internal tree nodes (this will greatly simplify the tree drawing algorithm). Finally, transforms some data to rate of change data, using branch length for rate calculation.

Parameters:prune_internal – if True, nodes with 1 offspring only will be

removed/collapsed and their branch length added to the preceding node on the branch.

ete_calc_lca_depth(ete_tree)[source]

Calculate the distance from the last common ancestor to the farthest leaf in an ete tree.

Parameters:ete_tree (TreeNode) – ete tree root node
Returns:int
Return type:depth of LCA
ete_convert_feature_to_cummulative(ete_tree_struct, feature, ete_root)[source]

Convert annotated feature values to cummulative values.

By starting at the root, values further down the tree can be computed by adding values calculated for the parent node. It is useful when for example the aim is to prune away internal nodes and rates of change of a feature need to be calculated on the pruned tree.

ete_convert_feature_to_rate(ete_root, feature, replace_tup=('count', 'rate'))[source]

Convert an annotated feature on the tree nodes to a rate.

The function assumes cummulative values of the feature. The rate is calculated by dividing the difference of the feature value between a parent and child by the corresponding branch length.

ete_cummulative_features(ete_tree_struct, features=[], func_features={}, ete_root=None)[source]
ete_get_lca(ete_tree, nodes=None)[source]

Return last common ancestor (LCA) for a set of nodes.

(default: all leafs of the current tree)

Parameters:
  • ete_tree (TreeNode) – ete tree root node
  • nodes (list of ete3.TreeNode) – nodes in tree for which to find LCA
Returns:

TreeNode

Return type:

the last common ancestor

ete_get_phylo2ete_dict(ete_tree_struct, nodes=None)[source]

Return mapping from ete PhyloUnits to lists of ete TreeNode objects.

The mapping is constructed for a set of TreeNodes nodes. The default action is to map all the TreeNodes in the current ete_tree.

Parameters:nodes (sequence) – sequence of TreeNodes
Returns:
Return type:dictionary from :class:`VirtualMicrobes.virtual_cell.PhyloUnit.PhyloUnit`s to list of :class:`ete3.TreeNode`s
ete_init_mappings(ete_tree)[source]

Construct helper dictionaries for converting TreeNode names to TreeNodes and TreeNode names to PhyloUnits.

ete_n_most_distant_leafs(ete_root, n)[source]

Find n leafs that are most diverged from eachother.

First, the oldest n subtrees are determined. Then, for all subtrees the farthest lying leaf is returned.

Parameters:
  • n – number of leafs
  • root – starting point for search (default is the ete_tree root)
ete_n_most_distant_phylo_units(ete_tree_struct, n=2, root=None)[source]

Convenience function to return phylo units after finding ‘ete_n_most_distant_leafs’ (see below) :param root: phylo unit used as root

ete_n_oldest_subtrees(ete_root, n)[source]

Find n oldest subtrees under root.

Iteratively expands the oldest subtree root into its children until the desired number of subtrees is in the list. Return as a list of tuples of (subtree, distance-from-root).

Parameters:
  • n (int) – number of subtrees
  • root (TreeNode) – start point for subtree search
Returns:

subtrees

Return type:

a list of (TreeNode, distance)

ete_named_node_dict

Return the ete_named_node_dict belonging to the first ete tree.

See also

func
ete_tree
ete_node_name_to_phylo_node

Return the ete_node_name_to_phylo_node belonging to the first ete tree.

See also

func
ete_tree
ete_node_to_phylo_unit(ete_tree_struct, ete_node)[source]

Maps TreeNode to PhyloUnit.

Parameters:ete_node (TreeNode) – node to map
Returns:
Return type:PhyloUnit
ete_nodes_to_phylo_units(ete_tree_struct, nodes=None)[source]

Obtain a list of all the phylo units that are represented in the ete tree.

The ete_tree is traversed and ete node names are mapped first to PhyloTree nodes. The PhyloNodes have a reference to the PhyloUnit in their ‘val’ attribute.

ete_phylo_to_ete_birth_nodes(ete_tree_struct, phylo_unit)[source]

Return iterator over birth nodes in the ete tree for a phylo unit.

Parameters:phylo_unit (VirtualMicrobes.virtual_cell.PhyloUnit.PhyloUnit) – phylounit to map
Returns:
Return type:iterator of ete3.TreeNode
ete_phylo_to_ete_death_node(ete_tree_struct, phylo_unit)[source]

Return TreeNode representing the death of a phylo_unit.

ete_phylo_to_ete_stem_nodes(ete_tree_struct, phylo_unit)[source]

Return iterator over stem nodes in the ete tree for a phylo unit.

The stem nodes represent replication and death of the phylounit.

Parameters:phylo_unit (VirtualMicrobes.virtual_cell.PhyloUnit.PhyloUnit) – phylounit to map
Returns:
Return type:iterator of ete3.TreeNode
ete_prune_external(ete_tree_struct, prune_depth)[source]

Prune nodes of the external part of the tree beyond a certain depth.

The prune_depth is a time point in simulation time beyond which all subsequent nodes should be pruned and removed from the tree.

Parameters:
  • ete_struct (VirtualMicrobes.my_tools.utility.ETEtreeStruct) – struct holding data for the ete tree
  • prune_depth (int) – simulation time point beyond which nodes should be pruned
Returns:

Return type:

set of pruned internal ete3.TreeNode s

ete_prune_internal(ete_tree_struct)[source]

Excise all internal nodes that have a single child, while preserving the length of the branch.

Parameters:ete_struct (VirtualMicrobes.my_tools.utility.ETEtreeStruct) – struct holding data for the ete tree
Returns:
Return type:set of pruned internal ete3.TreeNode s
ete_prune_leafs(ete_tree_struct)[source]

Prune the external nodes of an ‘ete tree’.

Parameters:ete_tree_struct (VirtualMicrobes.my_tools.utility.ETEtreeStruct) – struct holding data for the ete tree
Returns:
Return type:set of pruned internal ete3.TreeNode s
ete_rate_features(ete_tree_struct, features=[], func_features={}, ete_root=None)[source]
ete_tree

Return the first ‘ete tree’ in the ete trees dict if it exists.

This is an adapter function during the transition to working with the multiple ete tree dictionary.

find_lca()[source]

Find the last common ancestor in the tree.

Start at the single root and go up until a branching point in the tree is found.

Returns:PhyloNode
Return type:LCA if it exists else None
nh_formats(roots=None, supertree=None, _format='newick')[source]
nodes_iter()[source]
phylo_to_ete_nodes(ete_tree_struct, phylo_unit, with_death=True)[source]

Return TreeNode objects in the ete_tree representing the birth and death nodes for this phylo_unit (e.g. cell or gene).

Parameters:
Returns:

Return type:

list of ete3.TreeNode

recalc_max_leaf_depth(leafs=None)[source]
reconnect_internal_nodes(internal_parent, internal_child)[source]
update(new_phylo_units=[], removed_phylo_units=[], new_roots=[])[source]
upgrade()[source]

Upgrading from older pickled version of class to latest version. Version information is saved as class variable and should be updated when class invariants (e.g. fields) are added. Adapted from recipe at http://code.activestate.com/recipes/521901-upgradable-pickles/

VirtualMicrobes.Tree.PhyloTree.newick(_id, time, branch_length)[source]
VirtualMicrobes.Tree.PhyloTree.nh_branch(_id, branch_length, features=None)[source]
VirtualMicrobes.Tree.PhyloTree.nhx(_id, time, branch_length)[source]
Module contents
VirtualMicrobes.cython_gsl_interface package
Submodules
VirtualMicrobes.cython_gsl_interface.integrate module

Document Manually …

VirtualMicrobes.cython_gsl_interface.odes module

Document Manually …

VirtualMicrobes.data_tools package
Submodules
VirtualMicrobes.data_tools.store module
class VirtualMicrobes.data_tools.store.DataCollection(save_dir='', name='dummy', filename=None)[source]

Bases: object

change_save_location(new_save_dir=None, copy_orig=True, current_save_path=None)[source]
get_data_point(index)[source]

Get a data point at index.

Exception catching to handle case where due to code update a loaded form of a DataStore does not yet hold a particular DataCollection. In that case a dummy dict producing empty numpy arrays is returned.

Parameters:index – key to a dict shaped data point
init_file(name=None, labels=[], suffix='.csv')[source]
prune_data_file_to_time(min_tp, max_tp)[source]

prune a data file by dropping lines starting from max_tp.

This function assumes that the first line contains column names and subsequent lines are time point data, starting with an comma separated (integer) time point.

Parameters:
  • max_tp – time point before which lines are dropped
  • max_tp – time point after which lines are dropped
update_data_points(index, dat)[source]
write_data()[source]
class VirtualMicrobes.data_tools.store.DataStore(base_save_dir, name, utility_path, n_most_frequent_metabolic_types, n_most_frequent_genomic_counts, species_markers, reactions_dict, small_mols, clean=True, create=True)[source]

Bases: object

Storage object for simulation data

Keep a store of simulation data that can be written to disk and retrieved for online plotting. Typically, the store will only hold the most recent data points before appending the data to relevant on disk storage files.

add_ancestry_data_point(comp_dat, ref_lods, time_point, leaf_samples=100)[source]

Compare lines of descent in a reference tree to a population snapshot at a previous time point.

The comp_dat is a po

add_best_data_point(best, attribute_mapper, time_point, affix='')[source]
add_cell_tc(cell, path, attribute_mapper, time_point, affix='')[source]
add_collection(dc)[source]
add_count_stats_dp(dc_name, dat, time_point)[source]
add_dp(dc_name, dat, time_point)[source]
add_eco_data_point(system, time_point)[source]
add_expression_data_point(system, time_point)[source]
add_frequency_stats_dp(dc_name, dat, column_names, time_point)[source]
add_gain_loss_dp(dc_name, cur_dat, prev_dat, time_point)[source]
add_list_dp(dc_name, dat, time_point)[source]
add_lod_binding_conservation(lod, stride, time_interval, lod_range)[source]
add_lod_data(lod, pop, env, stride, time_interval, lod_range)[source]
add_lod_network_data(lod, stride, time_interval, lod_range, save_dir=None)[source]
add_metabolic_stats_dp(dc_name, dat, time_point, cutoff=0.05)[source]
add_pop_data_point(system, time_point)[source]
add_raw_values_dp(dc_name, dat, time_point)[source]
add_simple_stats_dp(dc_name, dat, time_point)[source]
best_stats_dir = 'best_dat'
change_save_location(base_save_dir=None, name=None, clean=False, copy_orig=True, create=True, current_save_path=None)[source]
class_version = '1.7'
copy_utility_files()[source]
crossfeed_stats = ['crossfeeding', 'strict crossfeeding', 'exploitive crossfeeding']
eco_diversity_stats_dict = {'consumer type': <function <lambda>>, 'export type': <function <lambda>>, 'genotype': <function <lambda>>, 'import type': <function <lambda>>, 'metabolic type': <function <lambda>>, 'producer type': <function <lambda>>, 'reaction genotype': <function <lambda>>}
eco_stats_dir = 'ecology_dat'
eco_type_stats = ['metabolic_type_vector', 'genotype_vector']
fit_stats_names = ['toxicity', 'toxicity_change_rate', 'raw_production', 'raw_production_change_rate']
frequency_stats(dat, column_names)[source]
functional_stats_names = ['conversions_type', 'genotype', 'reaction_genotype', 'metabolic_type', 'import_type', 'export_type', 'tf_sensed', 'consumes', 'produces']
gain_loss(cur_dat, prev_dat)[source]
gain_loss_columns = ['gain', 'loss']
genome_dist_stats = ['copy_numbers', 'copy_numbers_tfs', 'copy_numbers_enzymes', 'copy_numbers_inf_pumps', 'copy_numbers_eff_pumps']
genome_simple_stats_names = ['tf_promoter_strengths', 'enz_promoter_strengths', 'pump_promoter_strengths', 'tf_ligand_differential_ks', 'enz_subs_differential_ks', 'pump_subs_differential_ks', 'pump_ene_differential_ks', 'tf_differential_reg', 'tf_k_bind_ops', 'enz_vmaxs', 'pump_vmaxs', 'tf_ligand_ks', 'enz_subs_ks', 'pump_ene_ks', 'pump_subs_ks']
genome_simple_val_stats_names = ['genome_size', 'chromosome_count', 'tf_count', 'enzyme_count', 'eff_pump_count', 'inf_pump_count', 'tf_avrg_promoter_strengths', 'enz_avrg_promoter_strengths', 'pump_avrg_promoter_strengths', 'tf_sum_promoter_strengths', 'enz_sum_promoter_strengths', 'pump_sum_promoter_strengths']
grid_stats = ['neighbor crossfeeding', 'strict neighbor crossfeeding', 'exploitive neighbor crossfeeding', 'grid production values', 'grid production rates', 'grid death rates', 'grid cell sizes', 'lineages', 'grid ages', 'grid genomesizes', 'grid divided', 'metabolic_type_grid']
grn_edits = {'': <function <lambda>>, '_pruned_1._cT_iT': <function <lambda>>}
init_ancestry_compare_stores(pop_hist)[source]
init_dict_stats_store(save_dir, stats_name, column_names, index_name='time_point', **kwargs)[source]
init_eco_data_stores(save_dir=None)[source]
init_expression_data_stores(save_dir=None)[source]
init_gain_loss_store(save_dir, stats_name, index_name='time_point', filename=None)[source]
init_list_stats_store(save_dir, stats_name)[source]
init_lod_stores(lod, met_classes, conversions, transports, first_anc, last_anc)[source]
init_phylo_hist_stores(phylo_hist)[source]
init_pop_data_stores(save_dir=None)[source]
init_save_dirs(clean=False, create=True)[source]

create the paths to store various data types

Parameters:
  • clean – (bool) remove existing files in path
  • create – create the path within the file system
init_simple_stats_plus_store(save_dir, stats_name, index_name='time_point')[source]
init_simple_stats_store(save_dir, stats_name, index_name='time_point', filename=None)[source]
init_simple_value_store(save_dir, stats_name, index_name='time_point', filename=None)[source]
init_stats_column_names(n_most_freq_met_types, n_most_freq_genomic_counts, species_markers, reactions_dict, small_mols)[source]

Initialize column names for various data collections :param n_most_freq_met_types: :param n_most_genomic_counts:

lod_stats_dir = 'lod_dat'
meta_stats_names = ['providing_count', 'strict_providing_count', 'exploiting_count', 'strict_exploiting_count', 'producing_count', 'consuming_count', 'importing_count', 'exporting_count']
metabolic_categories = ['producer', 'consumer', 'import', 'export']
mut_stats_names = ['point_mut_count', 'chromosomal_mut_count', 'stretch_mut_count', 'chromosome_dup_count', 'chromosome_del_count', 'chromosome_fuse_count', 'chromosome_fiss_count', 'sequence_mut_count', 'tandem_dup_count', 'stretch_del_count', 'stretch_invert_count', 'translocate_count', 'internal_hgt_count', 'external_hgt_count']
network_stats_funcs = {'all_node_connectivities': <function <lambda>>, 'degree': <function <lambda>>, 'in_degree': <function <lambda>>, 'out_degree': <function <lambda>>}
phy_dir = 'phylogeny_dat'
pop_genomic_stats_dict = {'chromosome counts': <function <lambda>>, 'genome sizes': <function <lambda>>}
pop_simple_stats_dict = {'ages': <function <lambda>>, 'cell sizes': <function <lambda>>, 'death rates': <function <lambda>>, 'differential regulation': <function <lambda>>, 'enz_subs_ks': <function <lambda>>, 'enzyme counts': <function <lambda>>, 'enzyme promoter strengths': <function <lambda>>, 'enzyme vmaxs': <function <lambda>>, 'exporter counts': <function <lambda>>, 'hgt neigh': <function <lambda>>, 'importer counts': <function <lambda>>, 'iterages': <function <lambda>>, 'offspring counts': <function <lambda>>, 'pos production': <function <lambda>>, 'production rates': <function <lambda>>, 'production values': <function <lambda>>, 'pump promoter strengths': <function <lambda>>, 'pump vmaxs': <function <lambda>>, 'pump_ene_ks': <function <lambda>>, 'pump_subs_ks': <function <lambda>>, 'regulator_score': <function <lambda>>, 'tf counts': <function <lambda>>, 'tf promoter strengths': <function <lambda>>, 'tf_k_bind_ops': <function <lambda>>, 'tf_ligand_ks': <function <lambda>>, 'times divided': <function <lambda>>, 'toxicity rates': <function <lambda>>, 'uptake rates': <function <lambda>>}
pop_stats_dir = 'population_dat'
prune_data_files_to_time(min_tp, max_tp)[source]
save_anc_cells(pop, time)[source]
save_dir
save_lod_cells(lod, stride, time_interval, lod_range, runtime)[source]
save_phylo_tree(pop, time)[source]
simple_stats(dat)[source]
simple_stats_columns = ['avrg', 'min', 'max', 'median', 'std', 'total']
simple_value(dat)[source]
simple_value_column = ['value']
snapshot_stats_names = ['historic_production_max']
trophic_type_columns = ['fac-mixotroph', 'autotroph', 'heterotroph', 'obl-mixotroph']
type_differences_stats(types, column_names)[source]
type_totals_stats(types, column_name)[source]
upgrade(odict)[source]

Upgrading from older pickled version of class to latest version. Version information is saved as class variable and should be updated when class invariants (e.g. fields) are added. (see also __setstate__)

Adapted from recipe at http://code.activestate.com/recipes/521901-upgradable-pickles/

write_data()[source]
write_genome_json(save_dir, name, genome, attribute_mapper, labels, suffix='.json')[source]
class VirtualMicrobes.data_tools.store.DictDataCollection(column_names, index_name, to_string=None, **kwargs)[source]

Bases: VirtualMicrobes.data_tools.store.DataCollection

Entry point for storing and retrieving structured data

update_data_points(index, data_dict)[source]
write_column_names(columns=None, index_name=None, to_string=None)[source]
write_data(sep=', ')[source]
class VirtualMicrobes.data_tools.store.ListDataCollection(**kwargs)[source]

Bases: VirtualMicrobes.data_tools.store.DataCollection

update_data_points(index, data_vector)[source]
write_data(sep=', ')[source]
VirtualMicrobes.data_tools.store.create_gene_type_time_course_dfs(cell)[source]
VirtualMicrobes.data_tools.store.create_tc_df(tc_dict)[source]
VirtualMicrobes.data_tools.store.eco_type_vector_to_dict(vect_dict)[source]
VirtualMicrobes.data_tools.store.tf_conservation_to_dict(tf_conservation_dict)[source]
VirtualMicrobes.data_tools.store.tf_name(tf)[source]
Module contents
VirtualMicrobes.environment package
Submodules
VirtualMicrobes.environment.Environment module

Created on Mar 9, 2014

@author: thocu

class VirtualMicrobes.environment.Environment.Environment(params, max_time_course_length=0)[source]

Bases: object

add_new_cells_to_grid(cell_gp_dict)[source]
cells_grid_diffusion(diff_rate=None)[source]

Cell diffusion on the grid.

diff_rate : float
Diffusion rate of cells to neighboring grid points.
class_version = '1.1'
clear_dead_cells_from_grid()[source]
clear_mol_time_courses()[source]
energy_mols
energy_precursors()[source]

Return set of metabolites that are direct precursors for the energy class molecules.

Construct this set by iterating over energy classes and map them to reactions that produce the energy classes.

Returns:
Return type:class:OrderedSet
expression_grid_data_dict()[source]

Return dictionary of spatial concentration data per metabolite (within cells)

external_molecules
find_reaction(match_string)[source]

Returns reaction that matches stringrepr.

fluctuate(time, p_fluct=None, influx_rows=None, influx_cols=None, mols=None, influx_dict=None)[source]

Influx fluctuation on the grid.

Sets new influx rates for influxed molecules depending on fluctuation frequency. Influx rates may vary between different sub-environments. Each sub-environment may define its own set of molecules that can be fluxed in.

Parameters:
  • time (int) – simulation time
  • p_fluct (float) – fluctuation frequency per influxed molecule
  • influx_rows (iterable) – a sequence of row indices on which molecules are exclusively influxed
  • influx_cols (iterable) – a sequence of columnt indices on which molecules are exclusively influxed
  • mols (list of :class:`VirtualMicrobes.event.Molecule.Molecule`s) – molecules for which new influx rates should be set
  • influx_dict (dict) – mapping from VirtualMicrobes.event.Molecule.Molecule to influx rate (float)
func_on_grid(gp_func, rows=None, cols=None)[source]

Apply a function to a set of grid points.

The function gp_func should take a VirtualMicrobes.environment.Environment.Locality as argument. A subset of grid points are selected by using rows and cols lists. If both rows and cols are given, select gps as a mesh of intersecting rows and cols.

Parameters:
grid_data_from_func(func)[source]
grid_toggle_update(updated=False)[source]
influx_change_gamma(influx, variance_fact, upper=None, lower=None)[source]
influx_change_range(param_space)[source]
init_anabolic_reactions(nr_anabolic=None, nr_reactants=None, max_products=None, max_path_conversion=None, max_free_energy=None)[source]

Initialize the set of anabolic reactions.

Anabolic reactions combine small molecules into larger molecules. If the total free energy of product(s) is larger than that of the substrates, energy molecules will also be consumed in the reaction until reaction is (as) balanced (as possible).

Parameters:
  • nr_catabolic (int) – number of reactions to generate
  • max_products (int) – maximum number of species produced in the reaction
  • min_energy (int) – minimum amount of energy produced as energy molecules
  • max_path_conversion (int) – maximum nr of reactions producing any molecule species
  • max_free_energy (int) – maximum free energy loss from reaction
Returns:

Return type:

list of VirtualMicrobes.event.Reaction.Convert reactions

init_catabolic_reactions(nr_catabolic=None, max_products=None, min_energy=None, max_path_conversion=None)[source]

Initialize the set of catabolic reactions.

Catabolic reactions break down large molecules into smaller molecules. If the total free energy of products is lower than that of the substrate, energy molecules will also be produced in the reaction until reaction is (as) balanced (as possible).

Parameters:
  • nr_catabolic (int) – number of reactions to generate
  • max_products (int) – maximum number of species produced in the reaction, excluding energy
  • min_energy (int) – minimum amount of energy produced as energy molecules
  • max_path_conversion (int) – maximum nr of reactions producing any molecule species
Returns:

Return type:

list of VirtualMicrobes.event.Reaction.Convert reactions

init_class_conversions(fraction_reactions)[source]
init_degradation()[source]
init_degradation_dict(degr_const=None, ene_degr_const=None, bb_degr_const=None, degradation_variance_shape=None)[source]

Initialize a global dictionary for degradation rates of molecules in the external environment.

init_diffusion()[source]
init_external_mol_vals_on_grid(init_conc=None)[source]

Initialize concentrations, degradation and influx rates of molecules on the grid.

init_global_influx_dict(influx=None)[source]

Initialize a global dictionary for influx rates of molecules in the external environment.

init_grid(verbose=False)[source]

Initialize the spatial grid. Set wrapping and barriers on particular neighborhoods.

init_influx()[source]
init_influxed_mols(fraction_influx=None)[source]

Select molecules that will be fluxed in in the external environment.

init_localities(number_localities, max_time_course_length=0, params_dict=None)[source]
init_membrane_diffusion_dict(diff_const=None, ene_diff_const=None, energy_proportional=None, diff_scaling_func=<function <lambda>>)[source]
init_microfluid_cycle()[source]

Sets up a list of dictionaries to iterate cycles of fixed external concentrations

init_mol_class_sizes()[source]
init_mol_classes()[source]
init_mol_toxicities(toxicity_avrg=None, toxicity_variance_shape=None, toxic_building_block=None)[source]
init_mols_to_reactions()[source]

Create dictionaries of reactions, keyed on the molecules procuced and consumed in the reactions.

init_reaction_universe()[source]
init_reactions()[source]
init_sub_envs(row_divs=None, col_divs=None, partial_influx=None, influx_combinations=None)[source]

Initialize sub-environments by dividing up the grid along rows and columns.

Within each subenvironment, influx can change independently. When partial_influx is chosen between 0 and 1, influxed molecules will only appear in a fraction of the subenvironments on the grid.

Parameters:
  • row_divs (int) – nr of divisions on y-axis
  • col_divs (int) – nr of divisions on x-axis
  • partial_influx (float) – fraction of molecules that will be influxed in each sub-environment
init_transports()[source]
map_variables()[source]
metabolite_grid_data_dict()[source]

Return dictionary of spatial concentration data per metabolite

metabolite_internal_grid_data_dict()[source]

Return dictionary of spatial concentration data per metabolite (within cells)

microfluid_chemostat(run_time=None)[source]
mix_metabolites(verbose=False)[source]

Mixes all metabolites over the grid perfectly

molecule_classes
mols_per_class_dict
perfect_mix(verbose=False)[source]

Perfect mix shuffles all gps

pick_mol_class(weighted_classes, rand_gen=None)[source]

Randomly select a molecule class with probability proportional to a weight.

Parameters:
Returns:

the selected class with its energy level and list index

Return type:

VirtualMicrobes.event.Molecule.MoleculeClass, energy, pos index

populate_localities(population)[source]
population_grid_data(data_func)[source]
population_grid_data_dict(marker_names, marker_select_func)[source]

Return a dictionary of spatial distribution of values per marker

Parameters:
  • marker_names – markers to probe on the grid
  • marker_select_func – how to select a marker value

when there are multiple individuals with different values per grid

population_grid_neighborhood_data(neighborhood_pop_func, neighborhood='competition')[source]
print_state()[source]
print_values()[source]
rand_anabolic_reaction_scheme(resource_classes, energy_classes, product_classes, nr_reactants, max_products, max_free_energy, max_ene_energy=1, rand=None)[source]

Construct a random anabolic reaction scheme.

Construction is done by randomly selecting a molecule classes as the substrates of the reaction and than select the molecule classes that will be the product of the reaction. The total energy of reactants ( + energy) >= products.

Parameters:
  • resource_classes (list of VirtualMicrobes.event.Molecules.MoleculeClass) – all resource molecule classes
  • energy_classes (list of VirtualMicrobes.event.Molecules.MoleculeClass) – energy molecule classes
  • max_products (int) – maximum number of products in reaction scheme
  • max_ene_energy (int) – maximum energy level that can be provided by energy metabolites as reaction substrate
Returns:

Return type:

reaction scheme tuple ( list of reactants, list of products, stoichiometries

rand_catabolic_reaction_scheme(substrate_classes, product_classes, energy_classes, max_products, min_energy, rand_gen=None)[source]

Construct a random catabolic reaction scheme.

Typically a catabolic reaction breaks down a large, energy rich molecule into smaller molecules. Energy molecules may be produced in this reaction.

Construction is done by randomly selecting a molecule class as the substrate of the reaction and than select the molecule classes that will be the product of the reaction. The total energy of reactants = products (+ energy).

Parameters:
  • substrate_classes (list of VirtualMicrobes.event.Molecules.MoleculeClass) – all resource molecule classes
  • product_classes (list of VirtualMicrobes.event.Molecules.MoleculeClass) – molecule classes that can be products of the reaction
  • energy_classes (list of VirtualMicrobes.event.Molecules.MoleculeClass) – energy molecule classes
  • max_products (int) – maximum number of products in reaction scheme
  • min_energy (int) – minimum yield in energy metabolites
Returns:

Return type:

reaction scheme tuple ( list of reactants, list of products, stoichiometries

reactions_dict
reset_grid_concentrations(conc=None)[source]
reset_grid_influx()[source]

Reinitialize the global infux dict and the per sub environment influx rates.

reset_locality_updates()[source]
resize_time_courses(new_max_time_points)[source]
resource_combis_within_energy(resource_classes, nr, total_energy)[source]

Return combinations of resource classes that have exactly a total sum in energy values.

Parameters:
  • resource_classes (set of :class:`VirtualMicrobes.event.Molecules.MoleculeClass`s) – the set to make combinations from
  • nr (int) – number of MCs to combine
  • total_energy (int) – the sum of energy values that MCs should have
Returns:

Return type:

combinations of MCs

select_building_blocks(nr_bb, mol_classes, substrate_weight_function=<function <lambda>>, weight_scaling=2, rand_gen=None)[source]
set_mol_concentrations_from_time_point()[source]
set_tot_volume()[source]
start_concentration_dict(init_conc=None, init_conc_dict=None, no_influx_conc=1e-20)[source]

Make dictionary of start concentrations for external molecules.

If the init_conc is not given, start with a concentration that is the equilibrium value based on influx and degradation rates of the metabolite.

Parameters:init_conc
sub_envs_influx_combinations(richest_first=True)[source]

Assign a subset of all influxed molecules per individual sub-environment.

Parameters:fract (float) – fraction of subenvironments where a molecule is fluxed in
sub_envs_partial_influx(fract)[source]

Assign a subset of all influxed molecules per individual sub-environment.

Parameters:fract (float) – fraction of subenvironments where a molecule is fluxed in
subgrids_gen(row_divs=1, col_divs=1)[source]

Generate partitions of the grid.

Partitions are constructed from the product of row-chunks and column- chunks, such that the grid is divided (approximately) equally according to the number of row- and column divisions.

Parameters:
  • row_divs (int) – number of divisions in the row dimension
  • col_divs (int) – number of divisions in the column dimension
Yields:

iterable of ‘(row_nrs, col_nrs)’ partitions of the grid

update_cells_on_grid(cell_gp_dict)[source]
update_localities()[source]
update_reaction_universe(path)[source]

Updates reaction universe by adding newly added molecules and reactions to the environment. Does NOT support the removal of metabolites / reactions, as this will often be very artificial for cells that are still using them.

update_volume(volume=None)[source]
upgrade()[source]

Upgrading from older pickled version of class to latest version. Version information is saved as class variable and should be updated when class invariants (e.g. fields) are added.

class VirtualMicrobes.environment.Environment.Locality(params, internal_molecules, influx_reactions, degradation_reactions, env_rand, max_time_course_length=0)[source]

Bases: object

add_cell(cell)[source]
add_small_molecule(mol, concentration=0.0)[source]
class_version = '1.0'
clear_locality()[source]

Clear the cells in this locality.

clear_mol_time_courses()[source]
get_cells()[source]
get_expression_level(rea, exporting=False)[source]
get_gene_prod_conc(gene)[source]
get_internal_mol_conc(mol)[source]
get_mol_concentration_dict()[source]

Get molecule concentration dictionary

get_mol_influx_dict()[source]

Get influx dictionary from locality dictionary

get_mol_per_class_concentration_dict()[source]
get_mol_per_class_influx_dict()[source]
get_mol_time_course_dict(max_tp=None)[source]

Get time course of molecule

get_small_mol_conc(mol)[source]
init_external_mols(conc=None)[source]
init_mol_time_course(mol_struct, length=None)[source]
init_mol_views()[source]

Sets alias to molecules in locality (QoL implementation)

init_time_courses(length=None)[source]

initialize an array to hold time course data of molecules

Parameters:new_max_time_points – max number of time points
init_variables_map()[source]
map_cell_gene_products(cell)[source]

The mapping is a dictionary of dictionaries; in this way, it is possible to recognize the same protein in the two different cells as two separate variables. (see also map_external_molecules)

Parameters:start_index
map_cell_internal_mols(cell)[source]
map_external_molecules()[source]

Mapping of the small molecules to indexes for use in the C integrator. The map is an initially empty dictionary. The first level of indexing is the container , while the second level is the molecules (type) . The container can be a cell or it can be the environment. (see also map_variables)

Parameters:start_index
map_variables()[source]

Setup of the mapping of variables in the system to indexes used by the C encoded integrator part of the simulation:

  • small molecules (metabolites, toxins, resources)
  • gene products

In practice we start with an empty dictionary and let ‘system’ map molecules and gene products sepselfarately, creating the indexes on the go and reporting back on the last selfused index.

remove_cell(cell)[source]
resize_time_courses(new_max_time_points)[source]
set_gene_prod_conc(gene, conc)[source]
set_mol_concentrations_from_time_point()[source]
set_small_mol_conc(mol, val)[source]
spill_dead_cell_contents(cell, prod_as_bb=None, factor=None)[source]
tp_index
update_small_mol_concentrations(concentration_dict)[source]
update_small_mol_degradation_rates(degradation_dict)[source]
update_small_mol_influxes(influx_dict, no_influx=1e-20)[source]
upgrade()[source]

Upgrading from older pickled version of class to latest version. Version information is saved as class variable and should be updated when class invariants (e.g. fields) are added.

VirtualMicrobes.environment.Grid module

Created on Nov 3, 2014

@author: thocu

class VirtualMicrobes.environment.Grid.Grid(rows, cols, neighborhood_dict=None, nei_wrapped_ew=None, nei_wrapped_ns=None)[source]

Bases: object

Grid will by default be wrapped, because the Neighborhood will index

as_numpy_array
columns_iter(cols, order='tb_lr')[source]

Iterate over gps in the selected columns :param cols: selected columns :param order: the order in which gps should be iterated

content_iter
disconnect_direction(gp, area, neighborhood)[source]

For all neighboring grid points lieing in a particular direction in a named neighborhood of a grid point gp, remove the gp coordinate from their neighborhoods.

e.g. if area is ‘south’ , the southern neighbors of gp will remove gp’s relative coordinate from their neighborhood

Parameters:
  • gp (GridPoint) – Grid point that will get unwrapped.
  • direction ({'north', 'south', 'east', 'west'}, optional) – The direction relative to the gp.
  • neighborhood (str) – named neighborhood for which the unwrapping is done
dummy()[source]
fill_grid(vals, order='lr_tb')[source]
get_gp(x, y)[source]
get_nei_gp(gp, direction_vect)[source]
gp_iter
gp_iter_in_order(order='lr_tb')[source]
grid_barriers(rand_gen, p_row=0.0, pos_row=None, max_fraction_width=None, p_col=0.0, pos_col=None, max_fraction_height=None, neighborhoods=None)[source]

Set up barriers in the grid

Parameters:
  • p_row
  • max_fraction_width
  • p_col
  • max_fraction_height
  • neighborhood
  • rand_gen
init_grid(rows, cols, neighborhood_dict, wrap_ew=None, wrap_ns=None)[source]
make_barrier(start_coord, length, neighborhood_name, direction='lr')[source]

Create a barrier on the grid where interaction between adjacent grid points is blocked.

Create a barrier in the given neighborhood_name by unwrapping gps on opposite sides of a line that is length long, starts at start_gp and extends along direction

mesh_iter(rows, cols, order='lr_tb')[source]

iterate over gps in a mesh, defined by intersections of rows and cols

normalize_coord(coord)[source]

Transform coordinate coord to an absolute grid coordinate with non- wrapped index.

Applies modulo cols and rows on the coordinates x and y value, respectively, to obtain a normalized coordinate.

Parameters:coord (VirtualMicrobes.my_tools.utility.Coord) – a coordinate on the grid that may be in wrapped index representation
Returns:
Return type:VirtualMicrobes.my_tools.utility.Coord
perfect_mix(rand_gen)[source]
rows_iter(rows, order='lr_tb')[source]

Iterate over gps in the selected rows

set_gp(x, y, gp)[source]
swap_content(gp1, gp2)[source]
swap_gps(gp1, gp2)[source]
swap_pos(pos1, pos2)[source]
toggle_gps_updated(updated=False)[source]
un_neighbor(gp, nei_rel_coord, neighborhood)[source]
unwrap_ew(neighborhood_name)[source]

Unwraps a grid neighborhood at its eastern and western borders.

Iterate over all grid points and detect when a grid point has neighbors that wrap over the east or west borders. Then remove the coordinate from the neighborhood.

Parameters:neighborhood_name (str) – The name of the neighborhood to unwrap

Notes

For a wrapped neighbor it is true that the difference between the focal gp coordinate and this neighbors (normalized) grid-coordinate is not equal to the its relative-coordinate (to focal gp).

unwrap_ns(neighborhood_name)[source]

Unwraps a grid neighborhood at its northern and southern borders.

Iterate over all grid points and detect when a grid point has neighbors that wrap over the north or south borders. Then remove the coordinate from the neighborhood.

Parameters:neighborhood_name (str) – The name of the neighborhood to unwrap

Notes

For a wrapped neighbor it is true that the difference between the focal gp coordinate and this neighbors (normalized) grid-coordinate is not equal to the its relative-coordinate (to focal gp).

update_gp(x, y, val)[source]
exception VirtualMicrobes.environment.Grid.GridError(value)[source]

Bases: exceptions.Exception

class VirtualMicrobes.environment.Grid.GridPoint[source]

Bases: object

content
coord
get_neighbor_at(rel_coord, neighborhood_name)[source]

Get neighboring grid point at a relative coordinate.

Parameters:
  • rel_coord (VirtualMicrobes.my_tools.utility.Coord) – coordinate relative to self
  • neighborhood_name (str) – Name of the neighborhood.
Returns:

The neighboring grid point.

Return type:

GridPoint

nei_grid_coords(neighborhood_name, area=None)[source]
nei_rel_coord_to_gp(neighborhood_name, area=None)[source]

List of (relative-coordinate,grid-point) tuples of the named neighborhood.

Parameters:
  • neighborhood_name (str) – Name of the neighborhood
  • area ({'north', 'south', 'east', 'west'}, optional) – Select only neighbors lying in a specific area.
Returns:

Return type:

list of (VirtualMicrobes.my_tools.utility.Coord, GridPoint) tuples

nei_rel_to_grid_coords(neighborhood_name, area=None)[source]

List of (relative-coordinate, grid-coordinate) tuples of the named neighborhood.

Parameters:
  • neighborhood_name (str) – Name of the neighborhood
  • area ({'north', 'south', 'east', 'west'}, optional) – Select only neighbors lying in a specific area
Returns:

Return type:

list of (VirtualMicrobes.my_tools.utility.Coord, VirtualMicrobes.my_tools.utility.Coord) tuples

neighbor_gps(neighborhood_name, area=None)[source]

Return list of grid points in a named neighborhood.

Parameters:
  • neighborhood_name (str) – Name of the neighborhood.
  • area ({'north', 'south', 'east', 'west'}, optional) – Select only neighbors lying in a specific area.
  • """
neighbors(neighborhood_name, area=None)[source]

Return list of grid point content values of neighbors in named neighborhood.

Parameters:
  • neighborhood_name (str) – Name of the neighborhood.
  • area ({'north', 'south', 'east', 'west'}, optional) – Select only neighbors lying in a specific area.
pos
random_neighbor(neighborhood_name, rand_gen, area=None)[source]

Get random neighbor from a named neighborhood.

Parameters:
  • neighborhood_name (str) – Name of the neighborhood.
  • rand_gen (random generator) – Random generator for neighbor drawing.
  • area ({'north', 'south', 'east', 'west'}, optional) – Select only neighbors lying in a specific area.
remove_neighbor_at(rel_coord, neighborhood_name)[source]

Remove a coordinate from a named neighborhood.

After removing the relative coordinate rel_coord, the corresponding grid point is no longer considered a neighbor of self when applying neighborhood functions.

Parameters:
  • rel_coord (VirtualMicrobes.my_tools.utility.Coord) – Coordinate relative to self.
  • neighborhood_name (str) – Name of the neighborhood.
updated
class VirtualMicrobes.environment.Grid.Neighborhood(neighbors)[source]

Bases: object

Neighborhood as grid indices (x,y coord tuples) relative to a focal gridpoint.

construct_moore_n(perim=1, exclude_self=True)[source]
construct_named_neighborhood(name)[source]
construct_neighbors(neighbors)[source]
construct_neumann_n(manhatten=1, exclude_self=True)[source]
get_rel_coords(area=None)[source]

Return a list of neighborhood coordinates that lie in an area of the compass relative to (0,0)

Parameters:area ({'north', 'south', 'east', 'west'}) – The named area (or ‘hemisphere’) in grid space relative to the origin (0,0).

Notes

N (0, 1) |
W E (-1,0) (1,0) |
S (0,-1) |

|________________________________________|

Returns:The coordinates that lie within the named area.
Return type:list of :class:`VirtualMicrobes.my_tools.utility.Coord`s
has_coord(rel_coord)[source]

Check that relative coordinate is part of this neighborhood.

Parameters:rel_coord (VirtualMicrobes.my_tools.utility.Coord) –
remove_coord(remove_coord)[source]

Remove a relative coordinate from the neighborhood.

Parameters:remove_coord (VirtualMicrobes.my_tools.utility.Coord) –
remove_direction(direction)[source]

Remove coordinates lying to the given direction on the grid, where the main compass points are translated into coordinates as follows:

The main compass points are translated into coordinates as follows:
N (0, 1)
W E (-1,0) (1,0)
S (0,-1)

e.g. when direction is ‘north’, all relative coordinates that lie northerly of the (0,0) will be removed.

Parameters:direction ({'north', 'south', 'east', 'west'}, optional) – Selects those coordinates in the neighborhood that lie in a particular direction (default is None, which implies returninng all coordinates.
exception VirtualMicrobes.environment.Grid.PositionOutsideGridError(x, y)[source]

Bases: VirtualMicrobes.environment.Grid.GridError

VirtualMicrobes.environment.Grid.mirror_rel_coord(coord)[source]
Module contents
VirtualMicrobes.event package
Submodules
VirtualMicrobes.event.Molecule module
class VirtualMicrobes.event.Molecule.Molecule(name, toxic_level=None, is_internal=True, pair=True, is_building_block=False, is_gene_product=False, mol_class=None, is_energy=False, environment=None, **kwargs)[source]

Bases: object

Molecule species.

An internally and external variant of each molecule is defined. Molecules can act as metabolites that can be converted in (enzymatic) reactions. Can diffuse over membranes and may be transported into or out of the cell.

class_version = '1.0'
energy_level
environment
index = 0
is_building_block
is_energy
is_gene_product
is_influxed
is_internal
mol_class
pair_up()[source]

Create a paired molecule for self on the other side of the Cell membrane.

When updating a property of self, the property of the paired molecule is automatically updated (if appropriate; e.g. toxic_level or is_energy)

set_building_block(val=True)[source]
short_repr()[source]
toxic_level
classmethod unique_index(increase=None)[source]
upgrade()[source]

Upgrading from older pickled version of class to latest version. Version information is saved as class variable and should be updated when class invariants (e.g. fields) are added.

class VirtualMicrobes.event.Molecule.MoleculeClass(name, molecule_species=None, energy_level=1, is_energy=False, has_building_block=False)[source]

Bases: object

Defines a class of related molecule species.

add_molecule(molecule)[source]

Add a molecule to this molecule class.

Parameters:molecule (VirtualMicrobes.event.Molecule) – a molecule
short_repr()[source]

A short string representation of the molecule class

class VirtualMicrobes.event.Molecule.MoleculeIndexer[source]

Bases: object

VirtualMicrobes.event.Reaction module
exception VirtualMicrobes.event.Reaction.BadStoichiometryException[source]

Bases: exceptions.Exception

class VirtualMicrobes.event.Reaction.ClassConvert(substrate, energy, product)[source]

Bases: VirtualMicrobes.event.Reaction.Convert

Convert molecules within the same molecule class.

Parameters:
init_sub_reaction_dicts()[source]

Write out dictionaries for the sub_reactions generated by sub_reactions()

class VirtualMicrobes.event.Reaction.Convert(reactants, products, stoichiometry)[source]

Bases: VirtualMicrobes.event.Reaction.Reaction

Conversion reaction type.

In a conversion reaction a set of reactants react and a set of products are produced. Both reactants and products are defined as VirtualMicrobes.event.Molecule.MoleculeClass. Therefore, a single Convert reaction represent a set of sub-reactions of sets of reactant- VirtualMicrobes.event.Molecule.Molecule, sets of product- VirtualMicrobes.event.Molecule.Molecule combinations.

A pairing rule governs the exact set of sub-reactions that can take place.

Parameters:
init_sub_reaction_dicts()[source]

Write out dictionaries for the sub_reactions generated by sub_reactions()

prod_species
reac_species
sub_reactions()[source]

Representation of sub-reactions.

Returns a list of all potential reaction schemes in the following form: ([ (reactant, stoichiometry), .. ], [ (product, stoichiometry) ..] ). The general scheme for reactions from and to Molecule Classes maps molecules within a MolClass on lhs to molecules in another class on the rhs as follows:

Reaction scheme as MoleculeClass scheme: A + B -> C , where A :{a0, a1, a2}, B:{b0, b1}, C:{c0, c1, c2*} will be translated into:

a0 + b0 -> c0 a1 + b0 -> c1 a2 + b0 -> c2*

a0 + b1 -> c0 a1 + b1 -> c1 a2 + b1 -> c2*

  • If certain molecule species do not exist (e.g. the c2 in the previous example does not

exist, the reaction is omitted from possible sub-reactions, and will therefor not take place. Note that products on the rhs will always be converted in to the species corresponding to the index of the substrate on the lhs. If there is more product than substrates, e.g. A -> C + D where D:{d0, d1}, then there will be subreactions for every possible species of D:

a0 -> c0 + d0 a0 -> c0 + d1

a1 -> c1 + d0 a1 -> c1 + d1

a2 -> c2 + d0 a2 -> c2 + d1

Example 2: F + G -> H + I , where F :{f0, f1, f2}, G:{g0}, H:{h0, h1} , I:{i0, i2} becomes:

f0 + g0 -> h0 + i0 f1 + g0 -> h1 + i0

.

class VirtualMicrobes.event.Reaction.Degradation(substrate, **kwargs)[source]

Bases: VirtualMicrobes.event.Reaction.Reaction

Degradation type reaction.

Represents degradation of a molecule. The reaction has no products. Thus, when molecules degrade, mass is not strictly conserved.

Parameters:substrate (VirtualMicrobes.event.Molecule.Molecule) – degrading molecule
reaction_scheme()[source]

Reaction scheme dictionary.

sub_reactions()[source]

Representation of sub-reactions.

In the case of Degradation reactions, only a single sub-reaction exists.

class VirtualMicrobes.event.Reaction.Diffusion(substrate, **kwargs)[source]

Bases: VirtualMicrobes.event.Reaction.Reaction

Diffusion type reaction.

A reaction representing diffusion over a barrier (here the cell membrane). No products are defined for this reaction. Methods implementing this reaction type will convert the external/internal variant of a VirtualMicrobes.event.Molecule.Molecule into the linked internal/external molecule type.

Parameters:substrate (VirtualMicrobes.event.Molecule.Molecule) – diffusing molecule
reaction_scheme()[source]

Reaction scheme dictionary.

sub_reactions()[source]

Representation of sub-reactions.

In the case of Diffusion reactions, only a single sub-reaction exists.

class VirtualMicrobes.event.Reaction.Influx(substrate, **kwargs)[source]

Bases: VirtualMicrobes.event.Reaction.Reaction

Influx type reaction.

A reaction representing influx of molecules into the environment.

Parameters:substrate (VirtualMicrobes.event.Molecule.Molecule) – molecule that fluxes in
reaction_scheme()[source]

Reaction scheme dictionary.

class VirtualMicrobes.event.Reaction.Reaction(type_, reactants, products, stoichiometry)[source]

Bases: object

Base class for reactions.

Reactions are rules to convert Molecules to other Molecules, or Transport Molecules from one volume to another volume. A reaction specifies its reactants and products as MoleculeClasses or Molecules. Because a MoleculeClass can hold multiple Molecules, one Reaction is in fact a collection of potential molecular reactions. The actualized reactions depend on the properties (binding affinities for specific Molecules) of the enzymes and the availability of Molecules.

Parameters:
short_repr()[source]

Shorter version of __str__

class VirtualMicrobes.event.Reaction.Transport(substrate_class, energy_source_class, sub_stoi, cost, **kwargs)[source]

Bases: VirtualMicrobes.event.Reaction.Reaction

A transport type reaction.

Substrates are transported over a membrane, typically requiring the consumption of an energy source. The substrate and energy source are defined as VirtualMicrobes.event.Molecule.MoleculeClass. Therefore, a single Transport reaction represent a set of sub-reactions of substrate- VirtualMicrobes.event.Molecule.Molecule, energy- VirtualMicrobes.event.Molecule.Molecule combinations.

Parameters:
init_sub_reaction_dicts()[source]

Write out dictionaries for the sub_reactions generated by sub_reactions()

sub_reactions()[source]

Representation of sub-reactions.

Sub-reactions of Transporters link a specific external substrate to its internal counterpart. Different energy sources yield combinatorial expansion.

VirtualMicrobes.event.Reaction.consumes(reactions)[source]

Set of consumed metabolic species.

Parameters:reactions (iterable of Convert or dict) – set of reactions
Returns:
Return type:set of :class:`VirtualMicrobes.event.Molecule.Molecule`s consumed in the reaction set.
VirtualMicrobes.event.Reaction.find_metabolic_closure(input_set, conversions)[source]

Find the autocatalytic closure of metabolites given a set of inputs and reactions.

Iteratively overlap the produced + influxed and consumed metabolites of the set of conversion reactions, yielding a set of ‘potentially autocatalytic metabolites’. Iterate over the set of ‘potentially autocatalytic reactions’ and require that all substrates of the reaction are in the set of ‘potentially autocatalytic’ metabolites. If not, remove the reaction from the ‘potentially autocatalytic’ reaction set.

Parameters:
  • input_set (iterable of VirtualMicrobes.event.Molecule.Molecule) – initial set to start expansion of metabolic set
  • conversions (iterable of :class:`Conversion`s) – enzymatic reactions that convert metabolites into other metabolites
Returns:

tuple – molecules and reactions in the core autocatalytic cycle.

Return type:

( set of :class:`VirtualMicrobes.event.Molecule.Molecule`s , set of :class:`Conversion`s)

VirtualMicrobes.event.Reaction.find_product_set(input_mols, conversions)[source]

Find metabolites that can be produced from a set of input metabolites, given a set of reactions.

Parameters:
  • input_mols (iterable of VirtualMicrobes.event.Molecule.Molecule) – initial set to start expansion of metabolic set
  • conversions (iterable of :class:`Conversion`s) – enzymatic reactions that convert metabolites into other metabolites
Returns:

Return type:

set of produced :class:`VirtualMicrobes.event.Molecule.Molecule`s

VirtualMicrobes.event.Reaction.produces(reactions)[source]

Set of produced metabolic species.

Parameters:reactions (iterable of Convert or dict) – set of reactions
Returns:
Return type:set of:class:`VirtualMicrobes.event.Molecule.Molecule`s produced in the reaction set.
Module contents

Created on Nov 12, 2013

author:thocu
VirtualMicrobes.mutate package
Submodules
VirtualMicrobes.mutate.Mutation module
class VirtualMicrobes.mutate.Mutation.ChromosomalMutation(chromosomes, genome)[source]

Bases: VirtualMicrobes.mutate.Mutation.Mutation

class VirtualMicrobes.mutate.Mutation.ChromosomeDeletion(chromosome, genome)[source]

Bases: VirtualMicrobes.mutate.Mutation.ChromosomalMutation

mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.ChromosomeDuplication(chromosome, genome)[source]

Bases: VirtualMicrobes.mutate.Mutation.ChromosomalMutation

mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.Fission(chromosome, genome, pos)[source]

Bases: VirtualMicrobes.mutate.Mutation.ChromosomalMutation

mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
pos
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.Fusion(chrom1, chrom2, genome, end1, end2)[source]

Bases: VirtualMicrobes.mutate.Mutation.ChromosomalMutation

end1
end2
mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.Insertion(chromosome, genome, stretch, insert_pos, is_external)[source]

Bases: VirtualMicrobes.mutate.Mutation.StretchMutation

Insertion of a stretch of exogenous genomic material

insert_pos
is_external
mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.Inversion(chromosome, genome, start_pos, end_pos)[source]

Bases: VirtualMicrobes.mutate.Mutation.StretchMutation

mutate(time)[source]

The invert is in place, hence pre- and post- mutation will appear the same

reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.Mutation(target, genomic_unit)[source]

Bases: object

Base class for mutations.

applied

indicates that the mutation has been applied

Type:boolean
genomic_target
Type:target of the mutation
post_mutation
Type:post mutation state of the genomic_target
genomic_unit
Type:contains the genomic_target
time

simulation time when first mutated

Type:int
applied
genomic_target
genomic_unit
mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
post_mutation
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

time
uid = 0
exception VirtualMicrobes.mutate.Mutation.MutationAlreadyAppliedError(value="Cannot 'reapply' if already applied")[source]

Bases: VirtualMicrobes.mutate.Mutation.MutationError

exception VirtualMicrobes.mutate.Mutation.MutationError[source]

Bases: exceptions.Exception

exception VirtualMicrobes.mutate.Mutation.MutationNotAppliedError(value="Cannot 'rewind' if not already applied")[source]

Bases: exceptions.Exception

class VirtualMicrobes.mutate.Mutation.OperatorInsertion(gene, chromosome, new_val, pos)[source]

Bases: VirtualMicrobes.mutate.Mutation.SingleGeneMutation

mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
new_val
par
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.PointMutation(gene, chromosome, par, new_val, pos)[source]

Bases: VirtualMicrobes.mutate.Mutation.SingleGeneMutation

mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
new_val
par
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.SGDeletion(gene, chromosome, pos)[source]

Bases: VirtualMicrobes.mutate.Mutation.SingleGeneMutation

class VirtualMicrobes.mutate.Mutation.SGDuplication(gene, chromosome, pos)[source]

Bases: VirtualMicrobes.mutate.Mutation.SingleGeneMutation

class VirtualMicrobes.mutate.Mutation.SingleGeneMutation(gene, chromosome, pos)[source]

Bases: VirtualMicrobes.mutate.Mutation.Mutation

mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
pos
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.StretchDeletion(chromosome, genome, start_pos, end_pos)[source]

Bases: VirtualMicrobes.mutate.Mutation.StretchMutation

mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.StretchMutation(chromosome, genome, start_pos=None, end_pos=None, stretch=None)[source]

Bases: VirtualMicrobes.mutate.Mutation.Mutation

end_pos
positive_positions()[source]
start_pos
stretch
class VirtualMicrobes.mutate.Mutation.TandemDuplication(chromosome, genome, start_pos, end_pos)[source]

Bases: VirtualMicrobes.mutate.Mutation.StretchMutation

mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

class VirtualMicrobes.mutate.Mutation.Translocation(chromosome, genome, start_pos, end_pos, target_chrom, insert_pos, invert)[source]

Bases: VirtualMicrobes.mutate.Mutation.StretchMutation

insert_pos
invert
mutate(time)[source]

Apply mutation.

Parameters:time (int) – simulation time
positive_positions()[source]
reapply()[source]

Reapply mutation after rewinding

rewind()[source]

Go back to the ancestral state.

Module contents
VirtualMicrobes.plotting package
Submodules
VirtualMicrobes.plotting.Graphs module
class VirtualMicrobes.plotting.Graphs.AttributeMap(mol_class_dict, reactions_dict, species_markers)[source]

Bases: object

activation_color(effect, domain=(-1, 1))[source]
color_mol(mol)[source]
color_mol_class(mc)[source]
color_protein(g)[source]
color_reaction(r)[source]
init_color_maps(species_markers)[source]
init_mol_class_color_dict(mol_class_dict)[source]
protein_type_line_style(type_)[source]
class VirtualMicrobes.plotting.Graphs.BindingNetwork(base_save_dir, name, attribute_dict=None, size=(35, 35), **kwargs)[source]

Bases: VirtualMicrobes.plotting.Graphs.Network

draw_network(self_marker=None, edge_effect='effect')[source]
init_network(cell, with_self_marker=True)[source]
layout_network_positions(prog)[source]

Compute and store node positions using a layout algorithm.

Parameters:prog (str) – layout algorithm
class VirtualMicrobes.plotting.Graphs.Genome(base_save_dir, name, attribute_dict, size=(10, 10), show=True, **kwargs)[source]

Bases: VirtualMicrobes.plotting.Graphs.Grapher

plot_genome_structure(cell, labels, video=None, max_size=None)[source]

Render the genome structure as a circular (plasmid-like) representation. :param cell: which genome is plotted

exception VirtualMicrobes.plotting.Graphs.GraphNotFoundError(value)[source]

Bases: VirtualMicrobes.plotting.Graphs.GraphingError

class VirtualMicrobes.plotting.Graphs.Grapher(base_save_dir, name, show=True, attribute_dict=None, clean=True, create=True)[source]

Bases: object

backup_plots()[source]
change_save_location(base_dir=None, name=None, clean=False, create=True)[source]
class_version = '1.0'
init_attribute_mapper(mol_class_dict, reactions_dict, species_markers)[source]
init_save_dir(clean=False, create=True)[source]
save_dir
save_fig(name=None, labels=[], title=None, suffix='.svg', copy_labels=None, **kwargs)[source]

Render and save a figure.

Parameters:
  • name (str) – base name of the figure
  • labels (iterable) – additional labels in file name
  • title (str) – printable title of figure
  • suffix (str) – file extension suffix
  • copy_labels (iterable) – additional labels for the filename of a copy of the figure
Returns:

Return type:

list of filenames of the saved figure(s)

save_fig2(ext, name=None, title=None, **kwargs)[source]

Render and save a figure.

Parameters:
  • name (str) – base name of the figure
  • title (str) – printable title of figure
  • suffix (str) – file extension suffix
Returns:

Return type:

filename of the saved figure

save_video(video=None, frame=None)[source]

Concat last plot to existing video (or, if first plot is made, make single framed video)

Parameters:
  • video (str) – alias to ffmpeg that is found during initialisation
  • frane (str) – frame number
  • suffix (str) – file extension suffix
Returns:

Return type:

filename of the saved figure

update_figure(show=None)[source]
upgrade(odict)[source]

Upgrading from older pickled version of class to latest version. Version information is saved as class variable and should be updated when class invariants (e.g. fields) are added. (see also __setstate__)

Adapted from recipe at http://code.activestate.com/recipes/521901-upgradable-pickles/

exception VirtualMicrobes.plotting.Graphs.GraphingError(value)[source]

Bases: exceptions.Exception

class VirtualMicrobes.plotting.Graphs.Graphs(base_save_dir, name, utility_path, mol_class_dict, reactions_dict, population_markers, species_markers, show, clean=True, create=True, **kwargs)[source]

Bases: VirtualMicrobes.plotting.Graphs.Grapher

Produces static and online graphs of simulated data.

add_grid_graphs_data(time_point, pop_grid_data_dict, small_mol_names, data_store, scaling_dict_updates, markers_range_dict)[source]
add_mol_evo_time_course_data(time_point, ext_res_conc_dict)[source]
add_multigraph(graph)[source]
add_pop_stats_data(time, most_fecundant_death_rate, most_fecundant_production, data_store, high_freq_cutoff=10)[source]
add_prot_grid_graphs_data(time_point, small_mol_names, reaction_dict, data_store)[source]
change_save_location(base_save_dir=None, name=None, clean=False, create=True)[source]
init_binding_network(show=None, clean=True, **kwargs)[source]
init_genome_structure(show=None, clean=True, **kwargs)[source]
init_grid_graphs(mol_class_dict, markers=[], nr_cols_markers=3, show=None, mol_classes_per_row=4, clean=True, **kwargs)[source]
init_metabolic_network(metabolites, conversions, imports, show=None, clean=True, **kwargs)[source]
init_phylo_tree_graph(show=None, clean=True, **kwargs)[source]
init_pop_stats(species_markers, reactions_dict, mol_class_dict, clean=True, show=None, **kwargs)[source]
init_prot_grid_graphs(mol_class_dict, reactions_dict, nr_cols=4, show=None, mol_classes_per_row=4, reactions_per_row=4, clean=True, **kwargs)[source]
init_scaling_dict()[source]
init_time_course_graph(show=None, clean=True, **kwargs)[source]
line_colors(name, nr)[source]
plot_binding_network(*args, **kwargs)[source]
Parameters:
  • cell – Who to plot
  • prog – (???)
  • save – Save the figure Y/N
  • write – Save the network file (gml, dot, json, etc.)

Nodes: Pumping enzymes are BLUE squares (ip = importing pump, e-p = exporting pump) Generic enzymes are BLUE / TURQUOISE circles Specific enzymes are GREEN / YELLOW / RED circles TFs are BROWN diamonds Thick borders indicates self-binding

Node-labels: Labels: Metabolites with brackets are building blocks Metabolites with asterisks are energy carriers

Edges: Width shows the basal level of transcription for the TF Colours distinquish inhibiting (blue) vs activating (red) effects. Intermediates are white-ish.

!! Note: still needs the ReST references worked out !!

plot_genome_structure(**kwargs)[source]
plot_grid_concentrations(dat)[source]
plot_grid_graphs(*args, **kwargs)[source]
plot_metabolic_network(*args, **kwargs)[source]
plot_mol_class_data(ax, mol_tc_dict, **plot_params)[source]
plot_pop_stats(*args, **kwargs)[source]
plot_prot_data(ax, prot_pert_type_tc_dict, **plot_params)[source]
plot_time_course(*args, **kwargs)[source]
class VirtualMicrobes.plotting.Graphs.MetabolicNetwork(base_save_dir, name, mol_class_dict, conversions, imports, size=(30, 30), attribute_dict=None, **kwargs)[source]

Bases: VirtualMicrobes.plotting.Graphs.Network

color_reactions(conversions, imports, building_blocks=[], self_marker=None, reac_color_func=None, mol_color_func=None, edge_color_func=None)[source]
draw_network(reactions_dict=None, self_marker=None, building_blocks=None)[source]
init_network(mol_class_dict, conversions, imports)[source]
layout_network_positions()[source]
class VirtualMicrobes.plotting.Graphs.MultiGraph(base_save_dir, name, rows, cols, row_heigth=2, col_width=4, attribute_dict=None, show=True, **kwargs)[source]

Bases: VirtualMicrobes.plotting.Graphs.Grapher

add_axis(name, pos, rows=1, cols=1, min_max_y=None, nr_lines=0, auto_scale=True, **plot_params)[source]
add_lines(ax_name, nr_lines, **line_customization)[source]
append_data(axes_name, xdata, ydata)[source]
append_to_axes(axes_name, xdata, ydata, line_in=[], autoscale=True)[source]
append_to_lines(axes_name, xdat, ydata_dict, autoscale=True)[source]
colors = <Mock name='mock.cm.get_cmap()()' id='140713539737616'>
cols
customize_lines(lines, markers=None, line_styles=None, marker_sizes=None, marker_edge_widths=None, colors=None)[source]
fill_grid(pos, rows, cols)[source]
grid_free(pos, rows, cols)[source]
line_markers = <Mock name='mock.MarkerStyle.filled_markers' id='140713538203152'>
line_styles = ['-', ':', '--', '-.']
marker_edge_widths = [0.1]
marker_sizes = [2.0]
rows
tight_layout(**kwargs)[source]
within_grid(pos, rows, cols)[source]
class VirtualMicrobes.plotting.Graphs.MultiGridGraph(base_save_dir, name, rows, cols, row_heigth=4, col_width=4, attribute_dict=None, show=True, **kwargs)[source]

Bases: VirtualMicrobes.plotting.Graphs.MultiGraph

classdocs

add_axis(name, pos, rows=1, cols=1)[source]
append_data(axes_name, time_point, data)[source]
append_to_axes(axes_name, time_point, data)[source]
plot_in_axes(axes_name, cm_name, matrix_data=None, data_range=None, color_bar=True)[source]
set_data_range(axes_name, _range)[source]
class VirtualMicrobes.plotting.Graphs.Network(base_save_dir, name, attribute_dict, size=(10, 10), show=True, **kwargs)[source]

Bases: VirtualMicrobes.plotting.Graphs.Grapher

add_self(marker)[source]
clear_graph()[source]
color_edge_direction(i)[source]
e_attr_list(attr, selectors=[])[source]
edges_with_attr_list(selectors=[])[source]
gene_node_id(gene)[source]
gene_node_label(gene_node_id, depth=1)[source]
init_network()[source]
metabolite_edge_width(bb, cell_bb=False)[source]
n_attr_list(attr, selectors=[])[source]
nodes_with_attr_list(selectors=[])[source]
redraw_network(**kwargs)[source]
type_shape(reac_type)[source]
write_to_file(name=None, labels=[], suffix='.gml', **kwargs)[source]
class VirtualMicrobes.plotting.Graphs.PhyloTreeGraph(base_save_dir, name, attribute_dict, show=True, **kwargs)[source]

Bases: VirtualMicrobes.plotting.Graphs.Grapher

Plot phylogenetic trees and represent the data in nodes with different layout styles.

compress_root_branch(root_branch_dist=20)[source]
metabolic_type_layout(node)[source]
metabolic_with_lod_layout(node)[source]
mutation_rates_layout(node, mut_type)[source]
node_layouts = ['metabolism', 'trophic_type', 'metabolic_with_lod']
rate_features = ['point_mut_rate', 'chromosomal_mut_rate', 'stretch_mut_rate', 'sequence_mut_rate', 'chromosome_dup_rate', 'chromosome_del_rate', 'tandem_dup_rate', 'stretch_del_rate', 'external_hgt_rate', 'internal_hgt_rate']
save_fig(feature='metabolism', name=None, labels=[], suffix='.svg', rescale=None, dpi=10, **kwargs)[source]

Render tree with layout function depending on the selected feature for tree representation.

Parameters:
  • feature – feature selects for a specific layout function, determining node style
  • name – name for saving
  • labels – labels to appear in save file name
  • suffix – suffix of save file name
select_layout_fn(data_type)[source]
trophic_type_layout(node, trophic_type)[source]
update(tree)[source]

Set new ete_tree.

update_figure(show=None, feature='metabolism', **kwargs)[source]
write_to_file(name=None, labels=[], suffix='.nw', **kwargs)[source]
exception VirtualMicrobes.plotting.Graphs.PositionOutsideGridError(value)[source]

Bases: VirtualMicrobes.plotting.Graphs.GraphingError

Module contents
VirtualMicrobes.post_analysis package
Submodules
VirtualMicrobes.post_analysis.lod module
class VirtualMicrobes.post_analysis.lod.LOD(lod, name, stride, time_interval, lod_range, save_dir=None)[source]

Bases: object

classdocs

standardized_production(test_params)[source]
strided_lod(stride, time_interval, lod_range)[source]

Sample individuals within a range of the LOD at regular intervals.

Either use a stride or a time interval to sample individuals from the lod. If a time interval is provided, ancestors are sampled that have a time of birth that is approximately separated by time_interval in the evolutionary simulation.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
Returns:

Return type:

list of ancestor VirtualMicrobes.virtual_cell.Cell.Cell s

t_interval_iter(time_interval)[source]

Iterate ancestors that are approximately ‘time_interval’ timesteps apart in their time of birth.

class VirtualMicrobes.post_analysis.lod.LOD_Analyser(args)[source]

Bases: object

Analyses the evolutionary history of a population by tracing ancestors in the line of descent.

Loads a simulation save from a file, keeping a reference in ref_sim. From this, initialise ref_pop_hist as a PopulationHistory object that analyses the phylogenetic tree of the population.

The PopulationHistory generates a LOD for 1 or more individuals in the saved population. For each LOD, evolutionary data and network and genome plots can be produced.

It is possible to load additional simulation snapshots that preceed the ref_pop_hist and compare individuals to their contemporaries present in the preceding populations. compare_saves contains a list of file names of populations-saves that should be compared.

anc_cells(runtime=None, tcs=False)[source]

Dump all cells in the fossil record (e.g. to map onto the newick trees)

args = None

config and command line arguments used for initialisation

compare_saves = []

names of snapshot files to copmare to ref_sim

compare_to_pops()[source]

Compare reference simulation to a set of previous population snapshots.

Compares each of the simulation snapshot saves in compare_saves to the ref_pop_hist. A PopulationHistory is constructed for each of the compare snapshots. Within the compare snapshot, individuals that correspond to the are part of (any of) the LOD`(s) of the :attr:`ref_pop_hist will be identified. Properties of these ancestors will then be compare with their statistical values for the whole population.

draw_ref_trees()[source]

Draw a reference phylogenetic tree, with individual, selected LODs marked

init_compare_saves(compare_saves)[source]

Parse and check compare saves parameter.

Compare saves can be either a list of file names or a list of generation times (or None). In the latter case, the file names should be constructed using the time point and the file name of the reference simulation. Checks are made to ensure files exist and also to ensure that no compares save points come after the reference simulation save point, as this would not make sense in the comparison functions.

init_ref_history(ref_sim=None, nr_lods=None, prune_depth=0, pop_hist_dir='population_history')[source]

Create a PopulationHistory from the ref_sim VirtualMicrobes.simulation.Simulation.Simulation object.

For the PopulationHistory object constructs its phylogenetic tree and prune back the tree to a maximum depth of (max_depth - prune_depth) counted from the root. Then create LOD objects representing the line of descent of the nr_lods most diverged branches in the tree.

Parameters:
  • ref_sim (VirtualMicrobes.simulation.Simulation.Simulation object) – simulation snapshot that is the basis for LOD analysis
  • nr_lods (int nr_lods) – nr of separate (most distant) LODs to initialize
  • prune_depth (int) – prune back the phylogenetic tree with this many timesteps
  • pop_hist_dir (str) – name of directory to store lod analysis output
lod_binding_conservation(stride=None, time_interval=None, lod_range=None)[source]

Write time series for TF binding conservation for LODs.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
lod_cells(stride=None, time_interval=None, lod_range=None, runtime=None)[source]

Write time series of evolutionary changes along all LODs.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
lod_graphs(stride=None, time_interval=None, lod_range=None, formats=None)[source]

Draw network and genome graphs for LODs

It is possible to set an interval and a range to sample individuals in the LOD.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD

Note

Either use a stride or a time interval to sample individuals from the lod.

lod_network_stats(stride=None, time_interval=None, lod_range=None)[source]

Write time series for evolutionary network property changes along all LODs.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
lod_stats(stride=None, time_interval=None, lod_range=None)[source]

Write time series of evolutionary changes along all LODs.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
lod_time_course_plots(stride=None, time_interval=None, lod_range=None, formats=None)[source]

Draw time course diagrams for individuals in the LODs.

It is possible to set an interval and a range to sample individuals in the LOD.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD

Note

Either use a stride or a time interval to sample individuals from the lod.

lod_time_courses(lod_range=None, chunk_size=None)[source]

Write time series of molecule concentrations within the LOD

It is possible to set a range to sample individuals in the LOD.

Parameters:
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
  • chunk_size (int) – number of generations in LOD to concatenate per chunk
pop_cells(runtime=None, tcs=False)[source]

Dump all cells in this save file

ref_pop_hist = None

PopulationHistory for the reference simulation (ref_sim) snapshot

ref_sim = None

VirtualMicrobes.simulation.Simulation snapshot to analyse

write_newick_trees()[source]

write newick trees for all phylogenies in attr:ref_pop_hist

class VirtualMicrobes.post_analysis.lod.PopulationHistory(sim, params, save_dir=None, prune_depth=None)[source]

Bases: object

Performs and stores evolutionary history analysis of VirtualMicrobes.simulation.Simulation.Simulation snapshots.

Generates LODs for 1 or more individuals in the population. Reconstruct the evolutionary events along the line of descent.

A reference PopulationHistory can also be compared to population history at earlier simulation time points. In this case the ancestors of individuals in the reference population history will be identified and compared to the rest of the population at that point in time. In this way, evolutionary biases on the line of descent can be brought to light.

anc_cells(pop, time)[source]

Write cell files for all cells in the ancestry, which can be mapped on the newick tree :param pop: :type pop: current population that contains the current_ancestry list :param time: :type time: run_time

draw_ref_trees(rescale=False)[source]

Output reference trees for phylogenetic trees with lods labeled.

Uses phylogenetic tree drawing methods to annotate the leaf nodes of lods. Reference trees give a visual overview of the position of the lods that are analysed in the tree.

dump_anc_cells(time)[source]

Dump all ancestors (perfect fossil record) to files, and also save the newick tree. Should be all in there?

dump_lod_cells(time)[source]

Dump all cells used in LOD analysis to files (i.o.w. a single lineages / subset of anc_cells)

dump_pop_cells(time, prunegens)[source]

Output current population cells as cellfiles

environment = None

Short cut to VirtualMicrobes.environment.Environment of sim.

identify_lod_ancestor(ete_tree_struct, lod)[source]

Identify the individual in the population that is on the line of descent (lod) under consideration.

The nodes in the ete tree corresponding to the lod will be annotated with a tag.

Parameters:
  • ete_tree_struct (VirtualMicrobes.my_tools.utility.ETEtreeStruct) – container structure for phylogenetic tree representations
  • lod (LOD) – line of descent
Returns:

init_lods(nr_lods, save_dir=None, stride=None, time_interval=None, lod_range=None)[source]

Initialize the line of descent (LOD) container objects.

Iterate over the phylogenetic trees of the population and for each tree select nr_lods leaf nodes that are at maximum phylogenetic distance.

For each of the selected leafs, construct a line of descent object (LOD).

Parameters:
  • nr_lods (int) – number of LOD objects per phylogenetic tree
  • save_dir (str) –
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
init_phylo_tree(prune_depth=None)[source]

Update the phylogenetic tree of the population.

Clears the change in the population of the final regular simulation step. Prunes back the tree to a maximum depth.

Parameters:prune_depth (int) – number of generations to prune from the leafs of phylogenetic tree
lod_binding_conservation(stride, time_interval, lod_range)[source]

Write time series for line of descent properties such as network connectivity, protein expression etc.

Either use a stride or a time interval to sample individuals from the lod.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
lod_cells(stride, time_interval, lod_range, runtime)[source]

Write cell files for line of descent

The leaf of the tree is saved as CellLeaf<LOD_ID>, and all it’s ancestors are saved as CellNode<BIRTHTIME>_<LOD_ID>.cell

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
lod_network_stats(stride, time_interval, lod_range)[source]

Write time series for line of descent properties such as network connectivity, protein expression etc.

Either use a stride or a time interval to sample individuals from the lod.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
lod_stats(stride, time_interval, lod_range)[source]

Write time series for line of descent properties such as network connectivity, protein expression etc.

Either use a stride or a time interval to sample individuals from the lod.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
lods_time_course_data(lod_range, chunk_size)[source]

Write time series data in the line of descent to files.

Concatenates time courses of individuals along a LOD. Concatenations are done in chunks of a chosen chunk_size. For each chunk .csv files are stored in a directory named part*n*, where n is the chunk number.

Parameters:
  • ancestors (list of VirtualMicrobes.virtual_cell.Cell.Cells) –
  • base_save_dir (str) –
  • viewer_path (str) – path to utility files for html data viewer
  • chunk_size (int) – length of chunks of concatenated data
lods_time_course_plots(stride, time_interval, lod_range, formats)[source]

Output time course graphs for the line of descent.

Either use a stride or a time interval to sample individuals from the lod.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
params = None

The (updated) simulation parameters.

plot_lod_graphs(stride, time_interval, lod_range, formats)[source]

Output metabolic, GRN and genome graphs for the line of descent.

Either use a stride or a time interval to sample individuals from the lod.

Parameters:
  • stride (int) – stride in generations for sampling individuals along the LOD
  • time_interval (int) – interval in simulation time for sampling individuals along the LOD
  • lod_range ((float,float)) – bounds in fractions of the total range of the LOD
population = None

Short cut to VirtualMicrobes.virtual_cell.Population.Population of sim.

prune_depth = 0

Number of generations from leaves to prune the phylogenetic tree of the pophist.

sim = None

The VirtualMicrobes.simulation.Simulation.Simulation snapshot for which this pophist was made.

time_point = None

Last simulation time of the sim.

tree_lods = []

List of lists of LODs. One list for each independent phylogenetic tree within the population.

write_newick_trees()[source]

Write newick representation of phylogenetic trees to files.

VirtualMicrobes.post_analysis.network_funcs module
VirtualMicrobes.post_analysis.network_funcs.prune_GRN(grn, log_dif_effect=0.5, rescue_regulated=True, iterative=True)[source]
VirtualMicrobes.post_analysis.network_properties module
class VirtualMicrobes.post_analysis.network_properties.PhyloGeneticAnalysis[source]

Bases: object

Analyze biological networks

VirtualMicrobes.post_analysis.network_properties.calculate_overlap(tf_connections, connections_of_homologous_tfs, closest_bound_homologs_dict)[source]

Calculate the overlap in bound genes between tf homologs.

Parameters:
Returns:

Tuple of fractions: [0]: Fraction of downstream genes who’s homologs are bound by a homolog of the reference TF. [1]: Fraction of new connections (averaged over tf homologs) per original connection of the reference TF.

Return type:

float,float

VirtualMicrobes.post_analysis.network_properties.find_homolog_distances(gene, genome, closest_homolog=False)[source]

Find homologs and their distance for a gene in a target genome.

Parameters:
VirtualMicrobes.post_analysis.network_properties.find_homologs(gene, genome)[source]

For a gene, find all its homologs in a given genome.

This is a naive approach that uses a combination of the gene’s type and its VirtualMicrobes.virtual_cell.Identifier.Identifier attribute to detect common descent.

Parameters:
Returns:

Return type:

The set of homologs of gene in the genome.

VirtualMicrobes.post_analysis.network_properties.tf_binding_overlap(cell1, cell2, closest_homolog=False, no_phylogeny=False, verbose=False)[source]

Measure the overlap in target genes for tf homologs in phylogenetically related individuals.

cell1 : VirtualMicrobes.virtual_cell.Cell.Cell
Reference individual for which to find homologs
cell2 : VirtualMicrobes.virtual_cell.Cell.Cell
Homologs of TFs and downstream targets will be detected in this individual.
closest_homolog : bool
Flag to filter found homologs to those that have the shortest phylogenetic distance to the gene.
verbose : bool
Print messages about homologs found.
Returns:Mapping from VirtualMicrobes.virtual_cell.Gene.TranscriptionFactor to (maximum) binding overlap score.
Return type:dict
Module contents
VirtualMicrobes.simulation package
Submodules
VirtualMicrobes.simulation.Simulation module

‘ Top level Simulation class that contains all objects and parameters of the simulation. Has a simulate method that executes the simulation loop, methods to save and reload, as well as initiate data storage and plotting.

class VirtualMicrobes.simulation.Simulation.EvoSystem(params)[source]

Bases: object

Sets up the Environment and the Population.

reinit_system_params(params, **param_updates)[source]
setup_environment()[source]
class VirtualMicrobes.simulation.Simulation.ODE_simulation(params)[source]

Bases: VirtualMicrobes.simulation.Simulation.Simulation

Set up a simulation. Initialize an EvoSystem and an Integrator. EvoSystem consists of a Population and Environment that are co-dependent. This is because a Cell in a Population can only choose its Reactions once the environment is set up and the reaction space is ready, while the reaction space can only be fully known, when all internal molecules have been defined in relation to Cells in the Population. To circumvent the problem, internal molecules will only exist as ‘ideal’ type molecules and then every Cell will contain a mapping from ‘ideal’ molecules to actual variables of the system.

init_spatial_integrator(diffusion_steps=None, report_frequency=None, step_function=None, init_step_size=None, absolute_error=None, relative_error=None, global_time=0.0)[source]
init_time_course_lengths()[source]
max_time_course_length()[source]
simulation_burn_in(burn_in_time=None, simulation_steps=1)[source]
simulation_step(global_time=None, diffusion_steps=None, delta_t_between_diff=None, report_frequency=None, release_delay=None, update_relative_error=None, verbal=False)[source]

A simulation step will run the integration of cycle of a cell’s life:

  • setup the variables_map needed
  • simulate internal dynamics
  • save variables states back to python objects (if no errors occured or > maxtries)
class VirtualMicrobes.simulation.Simulation.Simulation(params)[source]

Bases: object

Base class for Simulation objects.

Stores the simulation parameters.

Initializes output and storage paths and file for stdout and stderr logging.

Initializes a data store class for storing data points and time series.

Initializes a graphs class for output graphing, that will be fed with data points from the data store.

Has method for the main simulation loop.

Stores simulation snapshots that can be reloaded for further simulation or post analysis.

add_graphs_data(time_point)[source]
auto_restart_opts(retry_list=None, time=None)[source]

Automatically restart the simulation after the population became extinct.

A simulation can be automatically restarted from a previous save point. The save points to retry from in the retry_list are updated such that the most recent point is retried first and removed from this list. This ensures that a subsequent restart will not be attempted from the same save point, but will instead skip back to a preceding save point. When restarting the simulation, new parameter values will be chosen for a selected set of parameters, by applying a scaling factor v.

Parameters:retry_list (list) – list of population snapshots that can still be retried for restart
Returns:
Return type:(population save to retry, new parameter settings for retry)
backup_pop_stats()[source]
class_version = '2.6'
close_phylo_shelf()[source]
copy_config_files()[source]
describe_environment()[source]
init_data_store(clean=True, create=True)[source]

Initialize a DataStore object for storage of simulation data.

Data are kept in storage for retrieval by plotting functions until a call is made to write the raw data to a file (write_data).

init_error_log_file(save_dir=None, name='log', suffix='.err', labels=[])[source]
init_ffmpeg()[source]
init_graphs(show=None, clean=True, create=True)[source]

Initialize a Graphs object that contains simulation graphs.

Parameters:show – plot graphs on the X (blocking)
init_log_file(save_dir=None, name='log', suffix='.out', labels=[])[source]
init_log_files()[source]
init_phylo_linker_dict()[source]

Create a linker dict that maps phylogenetic units (PhyloUnit) to unique indices. This linker dict is used to mediate parent-child relations, while preventing that pickling recurses (heavily) on the phylogeny (no direct references to the objects)

init_save_dir(clean=None, remove_globs=['*.txt', '*.sav', '*.pck', '*.log', '*.err'])[source]
init_unique_gene_key()[source]

Initialize a generator for unique keys for use in the linker dict (see above).

init_unique_phylo_key()[source]

Initialize a generator for unique keys for use in the linker dict (see above).

open_log_file(name)[source]
open_phylo_shelf(name, flag)[source]

Open a Shelf like database object that can store (part of) phylogenetic units (PhyloUnit) to disk.

plot_and_save_graphs(time_point)[source]

Depending on the initialization parameter ‘graphs_single_core’ this will either run all plotting in functions in sequence (appending None to processes) or construct a list of job processes/ task tuples, to be run in parallel batch processes, separate from the main thread. These processes will be either put in a job queue or separately started by ‘_start_parallel_jobs’.

Parameters:time_point – simulation time point
plot_best_genome_structure(time_point)[source]
plot_grid_graphs(time_point)[source]
plot_networks(time_point)[source]
plot_pop_stats()[source]
plot_time_course(time_point)[source]
print_system_details()[source]
prune_data_store_files()[source]
reload_unique_gene_count()[source]
reload_unique_phylo_count()[source]
reopen_phylo_shelf(save_file=None)[source]
save(time=None, store=False)[source]

Save the simulation state as a snapshot.

Parameters:time (simulation time point) –
Returns:
Return type:filename of simulation save
save_dir

Return the simulation save path.

save_phylo_shelf(name=None, labels=[], suffix='.pck')[source]

Save a snapshot of the phylo_shelf, the global store of PhyloUnit objects.

Creating the snapshot enables reloading simulation saves with a correct state of the phylo_shelf.

set_phylo_shelf_file_name(name=None, suffix='.pck', labels=[])[source]
simulate()[source]

The main simulation loop.

Clear the population changes from previous iteration. Run the ode system. Apply HGT. Calculate death rates, determine deaths. Compete and reproduce. Mutate the offspring. Update the phylogeny. Store data and plot.

store_command_line_string(fn='command_line_string.txt')[source]
store_previous_save_dir()[source]

Save the location for data storage presently used in the simulation.

Useful to keep a history of save locations when simulations are reloaded and run with different data storage locations.

update_data_location(save_dir=None, graphs_name='plots', data_name='data', clean=False, copy_data=True, create=True, current_save_path=None)[source]

Moves existing data to a new location (e.g. when name of project has changed after propagating an existing population)

update_shelf_location(current_save_path=None)[source]
update_sim_params(params_dict)[source]

Update simulation parameters with values in an update dict.

Parameters:params_dict (dict) – dict with updated parameter values
upgrade(odict)[source]

Upgrading from older pickled version of class to latest version. Version information is saved as class variable and should be updated when class invariants (e.g. fields) are added. (see also __setstate__)

Adapted from recipe at http://code.activestate.com/recipes/521901-upgradable-pickles/

upgrade_graphs()[source]
write_data()[source]
write_params_to_file(save_dir=None, name='params', suffix='.txt', labels=[])[source]
VirtualMicrobes.simulation.Simulation.create_simulation(**param_updates)[source]
VirtualMicrobes.simulation.Simulation.default_params()[source]
VirtualMicrobes.simulation.Simulation.load_sim(file_name, verbose=False, **param_updates)[source]

Load a pickled representation of a saved simulation state.

Complementary method to :save_sim: to load and restore a simulation state. There is a possibility to update simulation parameters. The first stage of unpickling will reload the simulation parameters. This is necessary, because we need to set the ‘as_subprocess’ parameter for decorating Graph methods to be set before class initialization, by retrieving the ‘graphs_single_core’ parameter from the simulation ‘temp_params’ prior to reloading and recreating the pickled Graphs instance in the simulation object.

VirtualMicrobes.simulation.Simulation.load_sim_params(file_name)[source]
VirtualMicrobes.simulation.Simulation.load_simulation(file_name, **param_updates)[source]
VirtualMicrobes.simulation.Simulation.mut_func_single_param(val, rand_g, mut_par_space, up)[source]
VirtualMicrobes.simulation.Simulation.mut_func_single_param_step_uniform(val, rand_g, mut_par_space, up)[source]
VirtualMicrobes.simulation.Simulation.mut_ks_dict_func(kss, rand_gen, mut_par_space, mutate_single_param, up)[source]
VirtualMicrobes.simulation.Simulation.partial_mut_func_single_param(val, rand, mut_par_space, up=True)[source]
VirtualMicrobes.simulation.Simulation.partial_mut_ks_dict_func(val, rand, mut_par_space, up=False)[source]
VirtualMicrobes.simulation.Simulation.pump_exporting_mut_func(val)[source]
VirtualMicrobes.simulation.Simulation.save_pop_cells(sim, name=None, save_dir=None, labels=[], suffix='.sav')[source]
VirtualMicrobes.simulation.Simulation.save_sim(*args, **kwargs)[source]

Make a pickled save state of the simulation.

It (nearly) completely creates a pickle representation of the simulation, from which the simulation can be reloaded and continued, with parameters and state fully restored. Because a global linker dict with database functionality is used to store phylogenetic elements such as Genes, Chromosomes and Cells, a snapshot of this database needs to be created simultaneously. The snapshot of the DB is remembered within the simulation, to allow it to be reloaded when the saved simulation state is reloaded.

VirtualMicrobes.simulation.Simulation.save_single_cell(sim, cell, name=None, save_dir=None, labels=[], suffix='.sav')[source]
VirtualMicrobes.simulation.Simulation.tf_ext_sense_mut_func(val)[source]
VirtualMicrobes.simulation.Simulation.update_default_params(keep_unrecognized=False, verbose=False, **kwargs)[source]

Use simulate_params, pop_params and env_params as defaults and overwrite them with kwargs to construct a parameter dictionary. Warn for all kwargs that have not been consumed. ( default_params() generates all default parameters )

Parameters:
  • simulate_params – dictionary with general simulation parameters
  • pop_params – dictionary with population specific parameters
  • env_params – dictionary with environment specific params
VirtualMicrobes.simulation.virtualmicrobes module

Command Line Interface to the Virtual Microbes Evolutionary Simulator package.

@copyright: 2014 Theoretical Biology and Bioinformatics. All rights reserved.

@license: MIT licence

@contact: thomas.cuypers@gmail.com @deffield updated: Updated

Module contents
VirtualMicrobes.virtual_cell package
Submodules
VirtualMicrobes.virtual_cell.Cell module
class VirtualMicrobes.virtual_cell.Cell.Cell(params, environment, rand_gen, toxicity_function=None, toxicity_effect_function=None, time_birth=-1, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.PhyloUnit.PhyloUnit

GRN(genes=None, prot_color_func=<function <lambda>>, with_gene_refs=False, with_self_marker=False)[source]

Make Gene Regulatory Network representation of the regulated genome.

First, the lists of nodes and edges is generated for the given genes. Then, nodes are added to a Directed Graph (networkx.DiGraph) object with attributes that distinguish the gene type and other characteristics. Finally, edges are added with attributes that indicate e.g. binding strength.

Returns:
Return type:networkx.Digraph
add_gene_copy(gene, concentration=0.0, diff_constant=None, degr_constant=None)[source]

Add gene product to the cell. If the ‘gene’ is already present as a key in the subdictionary, adding it again means we have to increase the multiplicity of the gene product, since there are multiple genes coding for this gene product. Otherwise, we add an entry for this gene product.

Parameters:
  • gene (VirtualMicrobes.virtual_cell.Gene.Gene) – The gene for which copy number is increased.
  • concentration (float) – Initial concentration of gene product.
  • diff_constant (float) – Diffusion constant of gene product over the cell membrane. (If None, no diffusion is modeled)
  • degr_constant (float) – Degradation constant of gene product.
add_gene_product(gene, concentration=None)[source]

Initialize gene products from the genes in the genome.

Gene products have a concentration and degradation rate. ODE system integration will use the gene products as input variables.

Parameters:concentration (float) – initial concentration of gene products
add_small_molecule(mol, env, concentration, diff_const, degr_const)[source]

Add a metabolite to the internal Cell molecules and set its state.

Parameters:
add_small_molecules(env, conc, degr_const, ene_degr_const, bb_degr_const)[source]

Add the metabolites in the environment as internal variables to this individual.

Set a membraned diffusion rate and degradation rate for the molecules. Diffusion rates come from a dictionary of the environment. Degradation rates also come from a dictionary in the environment, but may be scaled with an ‘internal’ degr_const parameter to cause degradation rates to be different inside and outside of the cell.

Parameters:
  • env (VirtualMicrobes.environment.Environment.Environment) – environment containing metabolites
  • conc (float) – start concentration of all metabolites
  • degr_const (float) – degradation constant of metabolites
  • ene_degr_const (float) – degradation constant of energy metabolites
  • bb_degr_const (float) – degradation constant of building block metabolites
ancestral_mutations

Cumulative mutations in the line(s) of descent.

For each LOD of this individual concatenate all mutations in each mutation category that happened in the ancestors of this individual. Because multiple LODs might exist, return a list of dictionaries that hold all mutations that this lineage acumulated, per mutation category.

Returns:
Return type:list of mutation dictionaries of LODs
apply_hgt(time, gp, environment, rand_gene_params=None, mutation_rates=None, global_mut_mod=None, rand_gen=None, rand_gen_np=None, verbose=False)[source]

Applies HGT to a cell, and updates the GRN.

If applied HGT is applied, the gp updated flag is set to True, to inform integrator update in next timestep.

Parameters:
  • time (int) – time point in the simulation
  • gp (VirtualMicrobes.environment.Grid.GridPoint) – location of cell on the grid
  • environment (VirtualMicrobes.environment.Environment.Environment) – simulation environment containing all possible reactions to draw a random gene for external HGT
  • rand_gene_params (dict) – parameter space for properties of externally HGTed genes
  • mutation_rates (dict) – contains rates for eHGT and iHGT
  • global_mut_mod (double) – scaling factor for all mutation rates
  • rand_gen (RNG) –
  • rand_gen_np (RNG numpy) –
Returns:

Return type:

The applied mutations are returned

asexual(time)[source]

Asexual reproduction.

Parameters:time (int) – simulation time point
Returns:
Return type:VirtualMicrobes.virtual_cell.Cell.Cell
avrg_promoter_strengths
building_blocks

Building Blocks in metabolism of this individual.

calculate_raw_death_rate(base_rate, toxicity_scaling, toxic_effect_func=None)[source]

Raw death rate based on a base rate and the toxic effects of internal molecule concentrations.

Parameters:
  • base_rate (float) – base death rate
  • toxicity_scaling (float) – scaling constant for toxic effect
  • toxic_effect_func (func) – calculates surplus death rate due to toxicity
cap_lineage_marker(max_lin_marker)[source]
chromosomal_mut

List of chromosomal mutations of this individual.

chromosomal_mut_count

Number of chromosomal mutations of this individual.

chromosome_count
chromosome_del

List of chromosome deletions of this individual.

chromosome_del_count

Number of chromosomal deletions of this individual.

chromosome_dup

List of chromosome duplications of this individual.

chromosome_dup_count

Number of chromosomal duplications of this individual.

chromosome_fiss_count

Number of chromosomal fissions of this individual.

chromosome_fission

List of chromosome fissions of this individual.

chromosome_fuse_count

Number of chromosomal fusions of this individual.

chromosome_fusion

List of chromosome fusions of this individual.

chromosome_mutate_genome(time, mutation_rates, global_mut_mod, rand_gen, rand_gen_np, verbose)[source]

Apply chromosomal mutations to the genome.

Each type of chromosome mutation is applied independently. When a mutation is selected, one or two random chromosomes are chosen for the mutation. The mutation method return a Mutation instance, that is appended to a list of chromosome mutations. This list is returned.

Parameters:
  • time (int) – simulation time
  • mutation_rates (attr_dict) – dict with all mutation rates
  • global_mut_mod (float) – modifier for Cell wide mutation rate
  • rand_gen (RNG) –
  • rand_gen_np (RNG) – numpy random number generator
  • verbose (bool) – verbosity
Returns:

Return type:

list of Mutation objects

class_version = '3.0'
clear_mol_time_courses()[source]

Set time course arrays to None.

Notes

Reduces memory footprint of cell, for example before saving cell objects.

clone(time)[source]

Make a clone of this cell.

Clones are identical, having no mutations, and maintain a reference to the parent.

Parameters:time (int) – simulation time point
Returns:
Return type:VirtualMicrobes.virtual_cell.Cell
compute_product_toxicity(toxicity_func=None)[source]

Set toxicity effect of product.

consumer_type

Return the set of all metabolic classes consumed in enzymatic reactions by this cell.

consumes

Set of consumed metabolic species.

consuming_count

Number of metabolic classes consumed by this individual.

conversions_type

The set of conversion reactions in the genome.

copy_numbers
copy_numbers_eff_pumps
copy_numbers_enzymes
copy_numbers_inf_pumps
copy_numbers_tfs
delete_chromosome(chrom, time)[source]

Chromosome deletion.

Creates a mutation object that is then responsible for calling the appropriate genomic operations (deletion methods of chromosome and genome updation functions of genome. The Cell then updates its gene product counts accordingly.

Parameters:
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.ChromosomeDeletion

delete_genes(genes, time)[source]
delete_stretch(chrom, start_pos, end_pos, time, verbose=False)[source]

Delete a stretch of genes in the genome.

The chromosome, start position and end position (exclusive) uniquely determine a sequence of genes that will be deleted. The copy number of gene products in the cell is reduced. A Mutation object will be returned.

Parameters:
  • chrom (VirtualMicrobes.virtual_cell.Chromosome.Chromosome) – target chromosome
  • start_pos (int) – position index of the start of the stretch
  • end_pos (int) – position index of the end of the stretch
  • time (int) – simulation time
  • verbose (bool) – verbosity
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.StretchDeletion

die(time, verbose=False, clear_time_courses=False, wiped=False)[source]

Cell death.

Informs genomic units of cell death.

Parameters:
  • time (float) – simulation time point
  • verbose (mol : VirtualMicrobes.event.Molecule.Molecule) – metabolitebool report on cell death
  • clear_time_courses (bool) – set time courses to None
  • wiped (bool) – set if cell death was due to wiping of (a fraction of) the population
divide_volume(factor=2.0)[source]

Divide the volume of the cell.

Parameters:factor (float) – division factor
duplicate_chromosome(chrom, time)[source]

Chromosome duplication.

Creates a mutation object that is then responsible for calling the appropriate genomic operations (duplication methods in chromosome and genome updation functions of genome. The Cell then updates its gene product counts accordingly.

Parameters:
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.ChromosomeDuplication

eff_pump_count
enz_avrg_promoter_strengths
enz_promoter_strengths
enz_subs_differential_ks
enz_subs_ks
enz_sum_promoter_strengths
enz_vmaxs
enzyme_count
enzymes

Enzyme products in the Cell.

Notes

Can include gene products of genes that are no longer in the genome.

exploiting

Return the set of metabolic classes that are imported and consumed.

exploiting_count

Number of metabolic classes imported and consumed by this individual.

export_type

Return the set of all metabolic classes exported by this cell.

exporter_type

The set of export reactions in the genome.

exporting_count

Number of metabolic classes exported by this individual.

external_hgt

List of external Horizontal Gene Transfers of this individual.

external_hgt_count

Number of external Horizontal Gene Transfers of this individual.

fiss_chromosome(chrom, pos, time)[source]

Chromosome fission.

Breaks apart a chromosome at a given position. The two resulting parts will become new chromosome replacing the original in the genome. Creates a mutation object that is then responsible for calling the appropriate genomic operations.

Parameters:
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.Fission

classmethod from_file(parameter_dict, environment, init_rand_gen, file_path)[source]
classmethod from_params(parameter_dict, environment, init_rand_gen)[source]
fuse_chromosomes(chrom1, chrom2, end1, end2, time)[source]

Fusion of two chromosomes.

Two chromosomes are fused end to end. The new product replaces the original two chromosomes in the genome.

chrom1 : VirtualMicrobes.virtual_cell.Chromosome.Chromosome
first chromosome to be fused
chrom2 : VirtualMicrobes.virtual_cell.Chromosome.Chromosome
second chromosome to be fused
end1 : bool
indicate end or start of the first chromosome will be fused
end2 : bool
indicate end or start of the second chromosome will be fused
Returns:
Return type:VirtualMicrobes.mutation.Mutation.Fusion
gene_substrate_differential_ks(ks_param, genes)[source]

Calculate differences between K parameters per substrate for a list of genes.

Parameters:
  • ks_param (str) – type of parameter
  • genes (list) – list of genes for which to calculate the diffs
Returns:

Return type:

array of diffs per gene

gene_substrate_ks(ks_param, genes)[source]
gene_type_counts
generate_enzymes(nr_enzymes, env, rand_gen, metabolic_pathway_dict, prioritize_influxed=True)[source]

Generate the set of enzymes of the cell.

Uses heuristics for constructing ‘viable’ initial metabolic pathways for the production of building blocks and energy metabolites.

Parameters:
  • nr_enzymes (int) – number of enzymes to generate
  • env (VirtualMicrobes.environment.Environment.Environment) – environment provides the set of metabolites and possible metabolic reactions
  • rand_gen (RNG) –
  • metabolic_pathway_dict (dict) – dictionary to keep track of metabolites consumed and produced by the cell.
  • prioritize_influxed (bool) – first create enzymes that can utilize metabolites that are present (influxed) in environment
Returns:

Return type:

list of :class:`VirtualMicrobes.virtual_cell.Gene.MetabolicGene`s

generate_pumps(nr_pumps, env, rand_gen, metabolic_pathway_dict, import_first=True, prioritize_influxed=True)[source]

Generate set of transporters of the cell.

Use heuristics for connecting to the metabolic pathways formed so far by the enzymes present in the cell.

Parameters:
  • nr_pumps (int) – number of transporters to generate
  • env (VirtualMicrobes.environment.Environment.Environment) – environment provides the set of metabolites and possible metabolic reactions
  • rand_gen (RNG) –
  • metabolic_pathway_dict (dict) – dictionary to keep track of metabolites consumed and produced by the cell.
  • import_first (bool) – first create import enzymes for all metabolites that can be consumed in metabolism
  • prioritize_influxed (bool) – first create transporters that can import metabolites that are present (influxed) in environment
Returns:

Return type:

list of :class:`VirtualMicrobes.virtual_cell.Gene.Transporter`s

See also

generate_enzymes

generate_tfs(nr_tfs, env, rand_gen, metabolic_pathway_dict, bb_ene_only=False)[source]

Create TFs of the cell.

Prioritizes TFs that sense metabolites that are relevant for the cell, i.e. metabolites that are actively consumed or produced by the cell’s enzymes (or production function).

Parameters:
  • nr_tfs (int) – number of tfs to generate
  • env (VirtualMicrobes.environment.Environment.Environment) – environment provides the set of metabolites and possible metabolic reactions
  • rand_gen (RNG) –
  • metabolic_pathway_dict (dict) – dictionary to keep track of metabolites consumed and produced by the cell.
  • bb_ene_only (bool) – create TFs with either a building block or an energy carrier as ligand exclusively
Returns:

Return type:

list of :class:`VirtualMicrobes.virtual_cell.Gene.TranscriptionFactor`s

genes_get_prop_vals(genes, get_prop)[source]

Construct array of values of a gene property for all duplicates of a list of genes.

Parameters:
  • genes (list of VirtualMicrobes.virtual_cell:Gene:Gene objects) – The genes for which to list the proprty
  • get_prop (func [VirtualMicrobes.virtual_cell:Gene:Gene] -> value) – A function that takes a gene as argument and returns a value
Returns:

Return type:

numpy array

genome_size
genotype

Construct frozen set of the genotype classification of this cell.

The genotype represents the gene functionality that the cell is capable of. It is expressed as the total set of transport, enzymatic and transcription sensing capabilities of the cell.

Returns:
Return type:frozenset
genotype_vector(env)[source]

Construct boolean vector of gene-type presence-absence.

Parameters:env (VirtualMicrobes.environment.Environment.Environment) – environment relative to which the gene type presence absence is determined
Returns:
get_ancestor(gen_back, verbose=False)[source]
get_ancestor_at_time(time)[source]
get_cell_size_time_course()[source]

Time course of cell size.

get_gene_concentration_dict()[source]

Mapping of gene products to current concentration.

get_gene_degradation_dict()[source]

Mapping of gene products to degradation rates.

get_gene_diffusion_dict()[source]

Mapping of gene products to diffusion rates.

get_gene_multiplicities_dict()[source]

Mapping of gene products to copy numbers in the genome.

get_gene_prod_conc(gene)[source]

Get current gene product concentration.

Parameters:gene (VirtualMicrobes.virtual_cell.Gene.Gene) – gene product
Returns:
Return type:concentration value (float)
get_gene_time_course_dict()[source]

Fetches time courses for gene products (proteins)

Returns:
Return type:dictionary of all time courses
get_gene_type_time_course_dict()[source]

Return a dictionary of concentration time course data for different gene types.

get_mol_concentration_dict()[source]

Mapping of internal molecule species to current concentrations.

get_mol_degradation_dict()[source]

Mapping of internal molecule species to degradation rates.

get_mol_diffusion_dict()[source]

Mapping of internal molecule species to diffusion rates.

get_mol_time_course_dict()[source]

Mapping of internal molecule species to concentration time course.

get_pos_prod_time_course()[source]

Time course of positive component of production rate.

get_raw_production_time_course()[source]

Time course of raw production value.

get_small_mol_conc(mol)[source]

Get current metabolite concentration.

Parameters:mol (VirtualMicrobes.event.Molecule.Molecule) – metabolite
Returns:
Return type:concentration value (float)
get_time_points()[source]

Array of (data) time points stored.

get_total_expression_level(reaction, exporting=False)[source]

Get total expression of a certain type of reaction

Parameters:
  • reaction (VirtualMicrobes.event.Reaction) –
    or
    VirtualMicrobes.event.MoleculeClass

    reaction or moleculeclass for TFs

  • exporting – whether pump is exporting
Returns:

Return type:

concentration valule (float)

get_total_reaction_type_time_course_dict()[source]

Return a dictionary of summed time courses per reaction type.

Gets the time courses per gene type and then sums concentrations of gene products with the same reaction (enzymes/pumps) or ligand (tfs).

get_toxicity_time_course()[source]

Time course of cell toxicity.

grow_time_course_arrays(factor=1.5)[source]

Grow time course arrays if they cannot hold enough new time points.

Parameters:factor (float) – increase capacity with this factor
hgt_external(hgt_rate, global_mut_mod, environment, time, rand_gene_params, rand_gen)[source]

Insert a randomly generated (external) gene into the genome.

Gene is created with random parameters and inserted (as a stretch) into a randomly picked chromosome and position.

Parameters:
  • hgt_rate (float) – probability external hgt
  • global_mut_mod (float) – mutation scaling parameter of all mutation rates
  • environment (VirtualMicrobes.environment.Environment.Environment) – simulation environment containing all possible reactions to draw a random gene for external HGT.
  • time (int) – simulation time
  • rand_gene_params (dict) – parameter space for properties of externally HGTed genes
  • rand_gen (RNG) –
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.Insertion

hgt_internal(hgt_rate, global_mut_mod, gp, time, rand_gene_params, rand_gen, rand_gen_np)[source]

Insert a randomly chosen gene (stretch) from a neighboring individual into the genome.

Potential donor individuals come from the neighbourhood of a focal grid point. Once a donor individual is selected, a random gene is chosen to be transferred to this individual.

Parameters:
  • hgt_rate (float) – probability external hgt
  • global_mut_mod (float) – mutation scaling parameter of all mutation rates
  • gp (VirtualMicrobes.environment.Grid.GridPoint) – focal grid point to select donor individual
  • time (int) – simulation time
  • rand_gene_params (dict) – parameter space for properties of externally HGTed genes
  • rand_gen (RNG) –
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.Insertion

hybridize(second_parent, time)[source]
import_type

Return the set of all metabolic classes imported by this cell.

importer_type

The set of import reactions in the genome.

importing_count

Number of metabolic classes imported by this individual.

inf_pump_count
init_building_blocks_dict(nr_blocks, rand_gen, stois)[source]

Initialize the dictionary of cellular building blocks and their stoichiometry.

Parameters:
  • nr_blocks (int) – number of different metabolic building blocks of the cell.
  • rand_gen (RNG) –
  • stois (tuple of int) – (lower, higher) range of stoichiometric constants from which to randomly draw stoichiometries.
init_cell_params()[source]

Set cell parameters based on simulation parameter settings.

init_cell_time_courses(length=None)[source]

Initialize arrays to hold time course data.

Parameters:length (int) – initial length of array
init_energy_mols(environment)[source]

Store the energy molecules of the cell.

Parameters:environment (VirtualMicrobes.environment.Environment.Environment) – simulation environment that contains metabolic universe

Notes

energy_mols are used in odes.pyx

init_gene_products(concentration=None)[source]

Initialize gene products from the genes in the genome.

Gene products have a concentration and degradation rate. ODE system integration will use the gene products as input variables.

Parameters:concentration (float) – initial concentration of gene products
init_genome(environment, chrom_compositions=None, min_bind_score=None, prioritize_influxed=None, rand_gene_params=None, circular_chromosomes=None, better_tf_params=None, rand_gen=None, randomize=True)[source]

Iniitialize the genome of the cell.

The genome is constructed according to a list of chromosome composition descriptions. These descriptions specify the number of each gene type a set of chromosomes. Sets of metabolic , transport and transcription factor genes are initialized using heuristic functions that guarantee basic viability of the cell and a basic logic in transported and sensed metabolites, by taking into account the set of indispensible metabolites (building blocks and energy carriers). Finally, kinetic and other parameters of all genes are randomized and the genes distributed over the chromosomes.

Parameters:
  • environment (VirtualMicrobes.environment.Environment.Environment) – simulation environment that determines metabolic universe
  • chrom_compositions (list of VirtualMicrobes.my_tools.utility.GeneTypeNumbers) – per chromosome composition of different gene types
  • min_bind_score (float) – parameter for minimal binding score for transcription regulation
  • prioritize_influxed (bool) – first choose enzymatic reactions that use substrates that are influxed in environment
  • rand_gene_params (VirtualMicrobes.my_tools.utility.ParamSpace) – range from which to draw randomized gene parameters
  • circular_chromosomes (bool) – make the chromosomes circular
  • rand_gen (RNG) –
  • randomize (bool) – whether gene parameters should be randomized after creation
Returns:

Return type:

VirtualMicrobes.virtual_cell.Genome.Genome

init_mol_time_course(mol_struct, length=None)[source]

Initialize an array for time course data in a molecule structure SmallMol or GeneProduct.

Parameters:
  • mol_struct (VirtualMicrobes.my_tools.utility.SmallMol) – simple c-struct like object that holds data on small molecules or gene products
  • length (int) – initial length of time course array
init_mol_views()[source]

Initialize ‘aliases’ for the set of small molecules and that of gene products in the cell.

init_mutations_dict()[source]

Initialize a dictionary for storing the mutations in the life time of this cell.

init_time_courses()[source]

Initialize arrays that hold time course data for molecules and cell variables

insert_stretch(chrom, insert_pos, stretch, time, is_external, verbose=False)[source]

Insert a stretch of exogenous genomic material. Also adds product to the dict of to proteins made by the cell

internal_hgt

List of internal Horizontal Gene Transfers of this individual.

internal_hgt_count

Number of internal Horizontal Gene Transfers of this individual.

invert_stretch(chrom, start_pos, end_pos, time, verbose=False)[source]

Invert a stretch of genes in the genome in place.

The chromosome, start position and end position (exclusive) uniquely determine a sequence of genes that will be inverted. A Mutation object will be returned.

Parameters:
  • chrom (VirtualMicrobes.virtual_cell.Chromosome.Chromosome) – target chromosome
  • start_pos (int) – position index of the start of the stretch
  • end_pos (int) – position index of the end of the stretch
  • time (int) – simulation time
  • verbose (bool) – verbosity
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.Inversion

is_autotroph(env)[source]

Determine if cell is autotrophic within an environment.

Autotrophy is defined as the ability to produce building blocks from precursors that are present ‘natively’ in the environment. This may be done in a multistep pathway in which the cell produces intermediates with its own metabolic enzymes.

Parameters:env (VirtualMicrobes.environment.Environment.Environment) – the environment relative to which autotrophy is tested

See also

is_heterotroph()

is_clone(ref_cell)[source]

Is clone

Using string representation of genome to see if cells have the same genome

Parameters:ref_cell (VirtualMicrobes.virtual_cell.Cell.Cell) –
Returns:
Return type:bool
is_heterotroph(env)[source]

Determine if cell is heterotrophic within an environment.

Heterotrophy is defined as the ability to produce the building blocks from precursors that could only be present as (by)products from metabolism of other individuals in the environment, but not natively present (through influx).

Parameters:env (VirtualMicrobes.environment.Environment.Environment) – the environment relative to which autotrophy is tested

See also

is_autotroph()

mean_life_time_cell_size

Average cell size over the life time of the individual.

mean_life_time_pos_production

Average positive production value over the life time of the individual.

mean_life_time_production

Average production value over the life time of the individual.

mean_life_time_toxicity

Average toxicity value over the life time of the individual.

metabolic_type

Return a set of sets that uniquely defines the metabolic functions of this cell.

metabolic_type_vector(env)[source]

Construct boolean vector of metabolic capacity of the cell.

Based on the complete set of environmental molecule classes, write out a cells metabolism in terms of produced, consumed, imported and exported molecule classes by the cells metabolism.

Parameters:env (VirtualMicrobes.environment.Environment.Environment) – environment relative to which the metabolic capacity is determined
Returns:
  • mapping of metabolic-function to
  • :class:`VirtualMicrobes.event.Molecule.MoleculeClass`s presence/absence.
mutate(time, environment, rand_gene_params=None, mutation_rates=None, mutation_param_space=None, global_mut_mod=None, excluded_genes=None, point_mutation_dict=None, point_mutation_ratios=None, regulatory_mutation_dict=None, regulatory_mutation_ratios=None, rand_gen=None, rand_gen_np=None, verbose=False)[source]

Apply mutations to the genome.

In turn, chromosome mutations, gene stretch mutations, point mutations and regulatory region mutations are applied. Mutations happen with probabilities supplied in a mutation_rates dict. The parameter spaces of the different types of mutations are supplied in the mutation_param_space

Parameters:
  • time (int) – simulation time
  • environment (VirtualMicrobes.environment.Environment.Environment) – environment holds Metabolites that can be potential ligands
  • rand_gene_params (VirtualMicrobes.my_tools.utility.ParamSpace) – parameter space to draw new random parameter values
  • mutation_rates (attr_dict) – dict with all mutation rates
  • mutation_param_space (VirtualMicrobes.my_tools.utility.MutationParamSpace) – parameter space and bounds for mutation effect
  • global_mut_mod (float) – modifier for Cell wide mutation rate
  • point_mutation_dict (dict) – maps gene types to type specific parameter-> modifier-function mapping
  • point_mutation_ratios (dict) – mapping from parameter type to type specific relative mutation ratio
  • regulatory_mutation_dict (dict) – maps gene types to type specific parameter-> modifier-function mapping
  • regulatory_mutation_ratios (dict) – mapping from parameter type to type specific relative mutation ratio
  • rand_gen (RNG) –
  • rand_gen_np (RNG) – numpy random number generator
  • verbose (bool) – verbosity
Returns:

Return type:

list of mutations

mutate_neigh(p_mutate, mutation_param_space, global_mut_mod, rand_gen)[source]

Evolvable chance to ALWAYS take up a gene from a neighbour (1.0), OR, duplicate your own gene (0.0)

p_mutate : float
mutation probability
mutation_param_space : VirtualMicrobes.my_tools.utility.MutationParamSpace
parameter space and bounds for mutation effect
global_mut_mod : float
modifier for Cell wide mutation rate

rand_gen : RNG

Returns (void for now)

mutate_uptake(p_mutate, mutation_param_space, global_mut_mod, rand_gen)[source]

Apply mutations to rate of uptake of eDNA. Currently this uptake is a multiplier modulating the already existing natural occurence of transformation.

p_mutate : float
mutation probability
mutation_param_space : VirtualMicrobes.my_tools.utility.MutationParamSpace
parameter space and bounds for mutation effect
global_mut_mod : float
modifier for Cell wide mutation rate

rand_gen : RNG

Returns (void for now)

nodes_edges(genes=None)[source]

Returns a list of nodes and edges of the individual’s gene regulatory network.

Nodes are simply all the genes. Edges are TF binding site to operator interactions between genes in the nodes list.

Parameters:genes (list of :class:`VirtualMicrobes.virtual_cell.Gene.Gene`s) – genes for which to find nodes and edges. If None (default) all gene products in the cell that have copy nr > 0.
Returns:
Return type:nodes(list),edges(list of tuples)
point_mut

List of point mutations of this individual.

point_mut_count

Number of point mutations of this individual.

point_mutate_gene(chrom, pos, mut_dict, point_mut_ratios, environment, mutation_param_space, rand_gene_params, time, rand_gen)[source]

Mutate a gene at a particular position of a chromosome.

Depending on the ‘type’ of the gene, a different set of parameters may be mutated. One parameter of the gene randomly selected to be mutated, according to a weighted roulette wheel draw, with the probabilities given by the point_mut_ratios associated with each parameter. The selected parameter for the gene will be modified using a particular mut_modifier function for this parameter type. A VirtualMicrobes.mutate.Mutation.PointMutation object is constructed that holds references to the original and mutated gene and the old and new parameter value, and allowing for reversal of the mutation operation. Finally, append the mutation in the Cell’s list of single gene mutations.

Parameters:
  • chrom (VirtualMicrobes.virtual_cell.Chromosome.Chromosome) – chromosome that holds the gene to be mutated
  • pos (int) – position index of the gene to mutate
  • mut_dict (dict) – maps gene types to type specific parameter-> modifier-function mapping
  • point_mut_ratios (dict) – mapping from parameter type to type specific relative mutation ratio
  • environment (VirtualMicrobes.environment.Environment.Environment) – environment holds Metabolites that can be potential ligands
  • mutation_param_space (VirtualMicrobes.my_tools.utility.MutationParamSpace) – parameter space and bounds for mutation effect
  • rand_gene_params (VirtualMicrobes.my_tools.utility.ParamSpace) – parameter space to draw new random parameter values
  • time (int) – simulation time point that mutation is applied
  • rand_gen (RNG) –
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.PointMutation

point_mutate_gene_param(chrom, pos, param, mut_modifier, environment, mutation_param_space, rand_gene_params, time, rand_gen)[source]

Mutate a particular parameter of a gene at a particular position.

A random new value is drawn for the parameter. Then the point mutation is initialized and applied. The Cell’s gene products are updated to reflect the introduction of a new, mutated protein.

Parameters:
  • chrom (VirtualMicrobes.virtual_cell.Chromosome.Chromosome) – chromosome that holds the gene
  • pos (int) – position index of the gene to mutate
  • param (str) – name of parameter to mutate
  • mut_modifier (func) – function that from parameter value to new parameter value
  • environment (VirtualMicrobes.environment.Environment.Environment) – environment holds Metabolites that can be potential ligands
  • mutation_param_space (VirtualMicrobes.my_tools.utility.MutationParamSpace) – parameter space and bounds for mutation effect
  • rand_gene_params (VirtualMicrobes.my_tools.utility.ParamSpace) – parameter space to draw new random parameter values
  • time (int) – simulation time point that mutation is applied
  • rand_gen (RNG) –
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.PointMutation

point_mutate_genome(p_mutate, mut_dict, global_mut_mod, point_mut_ratios, excluded_genes, environment, mutation_param_space, rand_gene_params, time, rand_gen)[source]

Apply point mutations to genes in the genome, according to point mutation rate.

p_mutate : float
point mutation probability
mut_dict : dict
maps gene types to type specific parameter-> modifier-function mapping
global_mut_mod : float
modifier for Cell wide mutation rate
point_mut_ratios : dict
mapping from parameter type to type specific relative mutation ratio
environment : VirtualMicrobes.environment.Environment.Environment
environment holds Metabolites that can be potential ligands
mutation_param_space : VirtualMicrobes.my_tools.utility.MutationParamSpace
parameter space and bounds for mutation effect
rand_gene_params : VirtualMicrobes.my_tools.utility.ParamSpace
parameter space to draw new random parameter values
time : int
simulation time point that mutation is applied

rand_gen : RNG

Returns:
Return type:list of mutations applied in this round
pos_production

Current bruto production value.

producer_type

Return the set of all metabolic classes produced in enzymatic reactions by this cell.

produces

Set of produced metabolic species.

producing_count

Number of metabolic classes produced by this individual.

promoter_strengths
providing

Return the set of metabolic classes that are produced AND exported.

providing_count

Number of metabolic classes produced and exported by this individual.

prune_dead_phylo_branches()[source]

Prune branches of phylogenetic trees of all phylogenetically tracked entities.

Recursively, prunes phylogenetic branches of this individual if it is not alive. Also prunes phylogenies of phylogenetic entities in the genome.

Returns:
Return type:pruned cells (set), pruned chromosomes (set), pruned genes (set)
pump_avrg_promoter_strengths
pump_count
pump_ene_differential_ks
pump_ene_ks
pump_promoter_strengths
pump_subs_differential_ks
pump_subs_ks
pump_sum_promoter_strengths
pump_vmaxs
pumps

Transporter products in the Cell.

Notes

Can include gene products of genes that are no longer in the genome.

qual_expr_diff(ref_cell)[source]

Calculate a qualitative expression difference with a reference cell.

Parameters:ref_cell (VirtualMicrobes.virtual_cell.Cell.Cell) – reference cell to compare gene expression.
Returns:
Return type:mean positive (relative) difference of all gene expression values.
raw_production

Current production value.

raw_production_change_rate

Current production change rate value.

reaction_genotype

Construct frozen set of the reaction genotype classification of this cell.

The genotype represents the enzyme functionality that the cell is capable of. It is expressed as the total set of transport, enzymatic capabilities of the cell, but excluding the tf sensing capabilities.

Returns:
Return type:frozenset

See also

func
genotype
reaction_set_dict

Dictionary of enzymatic reaction types to reactions.

Reactions of genes are mapped to their reaction types (Conversion, Transport).

reaction_set_dict2

Dictionary of enzymatic reaction types to reactions.

Reactions of genes are mapped to their reaction types (Conversion, Transport).

Notes

Different formatting from reaction_set_dict.

read_genome(environment, gene_dict, genome_order, verbose=False)[source]

Reads and sets genome based on genes dictionary and a list of gene indexes representing the genome order.

Parameters:
  • environment (VirtualMicrobes.environment.Environment.Environment) – environment provides the reactions to match to the genes
  • gene_dict (dict) – dictionary that contains all properties of the gene most are just values such as v_max, prom_str, type etc. ene_ks and subs_ks are themselves dicts for each mol
  • genome_order (list) – a list of indexes that represent in what order the genes should be put into the genome
Returns:

Return type:

class:`VirtualMicrobes.virtual_cell.Genome

reduce_gene_copies(gene)[source]

Reduce the copy number for a gene.

Parameters:gene (VirtualMicrobes.virtual_cell.Gene.Gene) – The gene for which copy number is reduced.
regulatory_region_mutate(chrom, genome, pos, mut_dict, mut_ratios, stretch_exp_lambda, time, rand_gen, rand_gen_np)[source]

Mutate part of the sequence of a regulatory region of a gene.

The mutation may be either a copying and translocation of an existing sequence somewhere in the genome to new position, or the insertion of a random sequence.

chrom : VirtualMicrobes.virtual_cell.Chromosome.Chromosome
chromosome that holds the gene to be mutated
genome : VirtualMicrobes.virtual_cell.Genome.Genome
full genome to find donor sequence
pos : int
position on chromosome of gene to be mutated
mut_dict : dict
maps gene types to type specific parameter-> modifier-function mapping
mut_ratios : dict
mapping from parameter type to type specific relative mutation ratio
stretch_exp_lambda : float
geometric distribution parameter that determines expected stretch length
time : int
simulation time

rand_gen : RNG rand_gen_np : RNG

numpy random number generator
Returns:
Return type:VirtualMicrobes.mutation.Mutation.OperatorInsertion
regulatory_region_mutate_genome(mutation_rates, mut_dict, global_mut_mod, reg_mut_ratios, time, rand_gen, rand_gen_np)[source]

Apply regulatory region mutations to genes in the genome.

mutation_rates : attr_dict
dict with all mutation rates
mut_dict : dict
maps gene types to type specific parameter-> modifier-function mapping
global_mut_mod : float
modifier for Cell wide mutation rate
reg_mut_ratios : dict
mapping from parameter type to type specific relative mutation ratio
time : int
simulation time point that mutation is applied

rand_gen : RNG rand_gen_np : RNG

numpy random number generator
Returns:
Return type:list of mutations applied in this round
remove_unproduced_gene_products(conc_cutoff=None)[source]

Remove gene products when they are no longer produced and have a below threshold concentrations.

Parameters:conc_cutoff (float) – threshold concentration below which gene product is removed
Returns:True if any product was removed
Return type:bool
reproduce(spent_production, time, second_parent=None)[source]

Create a new child of this cell.

Copies all relevant properties, including the genome. Divides the original cell volume between the parent and child.

Parameters:
  • spent_production (float) – amount of the production variable spent for reproduction
  • time (int) – simulation time point
  • second_parent (VirtualMicrobes.virtual_cell.Cell.Cell) – an (optional) second parent that contributes to reproduction
Returns:

Return type:

VirtualMicrobes.virtual_cell.Cell.Cell

reset_grn(min_bind_score=None)[source]

Recalculate and reset all binding interactions in the genome.

Parameters:min_bind_score (float) – minimum identity score to set a regulatory interaction.
resize_time_courses(new_max_time_points)[source]

Set a new size for arrays that hold time course data.

Parameters:new_max_time_points (int) – max number of time points
scale_mol_degr_rate(mol, env, degr_const, ene_degr_const, bb_degr_const)[source]

Return scaled internal rate of metabolite degradation, relative to its external rate.

The base rate is the metabolite specific external degradation rate. If internal rates have been chosen (not None), the base rate will be scaled with the ratio of internal/external. Rates can be different for building block and energy metabolites.

Parameters:
Returns:

Return type:

scaled degradation rate (float)

sequence_mut

List of sequence mutations of this individual.

sequence_mut_count

Number of sequence mutations of this individual.

set_gene_prod_conc(gene, conc)[source]

Set the new concentration of a gene product.

The last concentration time point will be overwritten.

Parameters:
set_mol_concentrations_from_time_point()[source]

Record cellular concentrations and values from time course arrays.

During the integration step, for each molecule or other variable time course data is stored in an array. The position that was last filled is the new concentration. The value stored under index pos will be copied to a dedicated concentration or ‘value’ member.

Parameters:pos – position in array to
set_molconcs(concdict)[source]

Set molecule concentrations based on dict.

Parameters:concdict (dict) – dict with values for mol concentrations
set_properties(celldict)[source]

Set cell properties based on dict.

Parameters:celldict (dict) – dict with values for cell properties
set_small_mol_conc(mol, conc)[source]

Set the new concentration of a metabolite.

The last concentration time point will be overwritten.

Parameters:
set_small_mol_degr(mol, reac, rate)[source]

Set metabolite degradation parameter.

Parameters:
set_small_mol_diff(mol, reac, rate)[source]

Set metabolite diffusion parameter.

Parameters:
set_state_from_file(environment, filename)[source]

Set the state of the cell based on a configuration file.

Parameters:
set_state_from_ref_cell_tp(ref_cell, tp_index=0, verbose=False)[source]

Reset cell properties to the state of a reference cell at a chosen time point.

Parameters:
  • ref_cell (VirtualMicrobes.virtual_cell.Cell.Cell) – take values from this reference individual
  • tp_index (int) – index of reference time point to take reset value
  • verbose (bool) – verbosity flag
stretch_del

List of stretch deletions of this individual.

stretch_del_count

Number of stretch deletions of this individual.

stretch_invert

List of stretch inversions of this individual.

stretch_invert_count

Number of stretch inversions of this individual.

stretch_mut

List of stretch mutations of this individual.

stretch_mut_count

Number of stretch mutations of this individual.

stretch_mutate_genome(time, mutation_rates, global_mut_mod, rand_gen, rand_gen_np, mut_types=['tandem_dup', 'stretch_del', 'stretch_invert', 'stretch_translocate'], verbose=True)[source]

Iterate over chromosomes and positions to select stretches of genes for mutational events.

For every chromosome, iterate over positions and select front and end positions of stretch mutations. The direction of iteration is randomly chosen (back-to-front or front-to-back). Multiple mutations per chromosome may occur. Every position may be independently selected as the front site of a stretch mutation. The length of the stretch is a geometrically distributed random variable, using a lambda parameter. The end position is the minimum of the remaining chromosome length and the randomly drawn stretch length. If any positions remain in the chromosome after the stretch mutation, these positions are then iterated over in a random direction (direction of iteration is reversed at random after the application of the stretch mutation). Reversing direction is significant, because it randomizes the locations of ‘truncated’ stretches when reaching the end of a chromosome.

Parameters:
  • time (int) – simulation time
  • mutation_rates (attr_dict) – dict with all mutation rates
  • mut_dict (dict) – maps gene types to type specific parameter-> modifier-function mapping
  • global_mut_mod (float) – modifier for Cell wide mutation rate
  • rand_gen (RNG) –
  • rand_gen_np (RNG) – numpy random number generator
  • mut_types (list of str) – mutation types to apply
strict_exploiting

Return exploited resources classes that are not produced by self.

See also

exploiting()

strict_exploiting_count

Number of metabolic classes imported and consumed, but not produced by this individual.

strict_providing

Return provided resources classes that are not imported by self.

See also

providing()

strict_providing_count

Number of metabolic classes produced, exported but not consumed by this individual.

sum_promoter_strengths
tandem_dup

List of stretch duplications of this individual.

tandem_dup_count

Number of stretch duplications of this individual.

tandem_duplicate_stretch(chrom, start_pos, end_pos, time, verbose=False)[source]

Duplicate a stretch of genes in the genome in place.

The chromosome, start position and end position (exclusive) uniquely determine a sequence of genes that will be duplicated and inserted immediately behind the original stretch. A Mutation object will be returned.

Parameters:
  • chrom (VirtualMicrobes.virtual_cell.Chromosome.Chromosome) – target chromosome
  • start_pos (int) – position index of the start of the stretch
  • end_pos (int) – position index of the end of the stretch
  • time (int) – simulation time
  • verbose (bool) – verbosity
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.TandemDuplication

tf_avrg_promoter_strengths
tf_count
tf_differential_reg
tf_k_bind_ops
tf_ligand_differential_ks
tf_ligand_ks
tf_promoter_strengths
tf_sensed

The set of molecule classes that are sensed by TFs.

tf_sum_promoter_strengths
tfs

TF products in the Cell.

Notes

Can include gene products of genes that are no longer in the genome.

toxicity

Current toxicity value.

toxicity_change_rate

Current toxicity value change rate.

tp_index

Index of last time point stored.

translocate

List of stretch translocations of this individual.

translocate_count

Number of stretch translocations of this individual.

translocate_stretch(chrom, start_pos, end_pos, target_chrom, insert_pos, invert, time, verbose=False)[source]

Translocate a stretch of genes in the genome in place.

The chromosome, start position and end position (exclusive) uniquely determine a sequence of genes that will be excised and inserted at a new position in target chromosome. A Mutation object will be returned.

Parameters:
Returns:

Return type:

VirtualMicrobes.mutation.Mutation.Translocation

trophic_type(env)[source]

Trophic type classification of individual’s metabolic capacities.

Based on the metabolic reactions present in the individual’s genome an individual can be classified as being ‘autotrophic’ and/or ‘heterotrophic’. Facultative mixotrophs are defined as having both autotrophic and heterotrophic metabolic capacities, while obligate mixotroph are neither self-sufficient autotrophs, nor heterotrophs.

Parameters:env (VirtualMicrobes.environment.Environment.Environment) – the environment trophic type is determined in
truncate_time_courses(max_tp=None)[source]

Truncate the time course data.

If no maximum is supplied, truncates time courses to the parts of the arrays that have actually been filled with time points, discarding the empty last part of the array.

Intended to be called when a cell dies and no additional data points are expected to be stored.

Parameters:max_tp (int) – maximum number of time points retained
uid = 0

A Cell in the Simulation.

Initializes the state of the cell (without genome); notably:
  • internal molecule dictionaries
  • arrays to hold time course data of internal molecule concentrations
  • mutation dictionary, a record of mutations that occured during reproduction
  • internal state variables for volume, toxicity etc
Parameters:
  • params (attrdict.AttrDict) – mapping object that holds global simulation parameters
  • environment (VirtualMicrobes.environment.Environment) – environment that cell lives in; determines molecular and reaction universe
  • rand_gen (RNG) –
  • fromfile (path to .cell-file to reproduce cell from) –
  • toxicity_function (func) – calculates toxicity based on actual and threshold level of a concentration
  • toxicity_effect_function (func) – calculates added death rate from toxicity
update(state)[source]
update_grn(min_bind_score=None)[source]

Update the regulatory network, by finding (new) matches between TF binding sites and gene operators.

min_bind_score : float
minimum identity score to set a regulatory interaction.
update_mutated_gene_product(old, new)[source]

Decrease the copy number of the old gene and increase/initialize the new gene.

Parameters:
update_small_molecules(env, conc)[source]

Used when a new molecule enters the game

update_small_molecules_degr(env, degr_const, ene_degr_const, bb_degr_const)[source]

Update membrane degradation parameter of metabolites.

env : VirtualMicrobes.environment.Environment.Environment
environment containing reactions and base degradation rates.
update_small_molecules_diff(env)[source]

Update membrane diffusion parameter of metabolites.

env : VirtualMicrobes.environment.Environment.Environment
environment containing reactions and membrane diffusion rates.
upgrade()[source]

Upgrading from older pickled version of class to latest version. Version information is saved as class variable and should be updated when class invariants (e.g. fields) are added.

volume

Current cell volume.

VirtualMicrobes.virtual_cell.Cell.make_inherited_hgt_dict()[source]
VirtualMicrobes.virtual_cell.Cell.make_mutations_dict()[source]
VirtualMicrobes.virtual_cell.Chromosome module
class VirtualMicrobes.virtual_cell.Chromosome.Chromosome(gene_list=None, positions=None, time_birth=0, circular=False, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.PhyloUnit.PhyloBase

A chromosome contains genes in spatial order.

The chromosome class defines methods for chromosomal mutations * duplication * deltion * fission * fusion and mutations on the level of gene stretches * stretch deltion * stretch duplication * stretch inversion * stretch insertions

append_gene(g)[source]

Append gene at end of chromosome.

Parameters:g (class virtual_cell.Gene.Gene) – gene to add
delete_stretch(start_pos, end_pos)[source]

Deletes a stretch of genes.

Parameters:
  • start_pos (int) – first position of stretch
  • end_pos (int) – last position (exclusive) of stretch
Returns:

Return type:

iterable of genes; the deleted stretch

duplicate(time)[source]

Duplicate the chromosome.

Creates two identical copies of the chromosome. The original version is deleted.

Parameters:time (int) – simulation time
Returns:
Return type:Returns tuple of two chromosomes
fiss(pos, time)[source]

Chromosome fission.

A fission splits a chromosome, creating two new chromosomes.

Parameters:
  • pos (int) – position of fission
  • time (int) – simulation time
Returns:

Return type:

returns tuple of two chromosomes

classmethod fuse(chrom1, chrom2, time, end1=True, end2=True)[source]

Fuse two chromosomes.

Parameters:
Returns:

Return type:

returns the new fused chromosome

init_positions(circular=False)[source]

Initialize chromosome positions.

Parameters:circular (boolean) – if true define as circular list
insert_stretch(stretch, pos)[source]

Insert a stretch of genes at position.

Parameters:
  • stretch (iterable) – stretch of genes to insert
  • pos (int) – insert position
invert(start_pos, end_pos)[source]

Invert a stretch of genes.

Parameters:
  • start_pos (int) – first position of stretch
  • end_pos (int) – last position (exclusive) of stretch
Returns:

Return type:

iterable of genes; the inverted stretch

positions
tandem_duplicate(start_pos, end_pos)[source]

Duplicates a stretch of genes ‘in place’, and insert after end_pos.

Parameters:
  • start_pos (int) – first position of stretch
  • end_pos (int) – last position (exclusive) of stretch
Returns:

Return type:

iterable of genes; the duplicated stretch

toJSON(index, *args, **kwargs)[source]

Create JSON representation of chromosome.

Parameters:index (int) – a position index of the chromosome
Returns:
Return type:json dict
translocate_stretch(start_pos, end_pos, target_pos, target_chrom)[source]

Translocate a stretch of genes to a target chromosome and position.

Parameters:
  • start_pos (int) – first position of stretch
  • end_pos (int) – last position (exclusive) of stretch
  • target_pos (int) – position to insert stretch
  • target_chrom (VirtualMicrobes.virtual_cell.Chromosome.Chromosome) – target chromosome for insertion
uid = 0
VirtualMicrobes.virtual_cell.Gene module
class VirtualMicrobes.virtual_cell.Gene.Gene(type_, pr_str=1.0, operator_seq_len=10, operator=None, fixed_length=None, is_enzyme=False, promoter_phylo_type='base', operator_phylo_type='base', **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.GenomicElement.GenomicElement

Representation of gene in the genome.

Gene is the base class for various types of genes in the genome. A gene has * a set of type specific parameters * a promoter that determines basal gene expression level * an operator that allows interaction and expression modulation by

transcription factors
Parameters:
  • type (string) – type of gene
  • pr_str (float) – promoter strength
  • operator_seq_len (int) – sequence length of operator
  • operator (iterable) – operator sequence as bitstring
  • fixed_length (bool) – if false, operator length can change
  • is_enzyme (bool) – if true, is an enzyme type
is_enzyme
mutated(param, new_val, time, verbose=False)[source]

Mutates a parameter of the gene.

To maintain a full ancestry, the mutation should be applied to a (shallow) copy of the gene and this copy reinserted in the original ancestral position. The shallow copy will however have a new deepcopied version of the parameter dictionary so that the mutation will not affect the ancestral gene state.

Parameters:
  • param (string) – parameter to mutate
  • new_val (new parameter value) –
Returns:

Return type:

Returns the mutated copy of the gene.

operator
params
promoter
randomize(rand_gene_params, rand_gen, better_tfs=False, **kwargs)[source]

Randomizes gene properties.

Parameters:
  • rand_gene_params (dict) – parameters of randomization function
  • rand_gen (RNG) –
randomize_params(rand_gene_params, rand_generator)[source]
toJSON(attr_mapper, index, d=None, *args, **kwargs)[source]

Create JSON representation of gene.

Parameters:attr_mapper (dict) – mapping from properties to colours
Returns:
Return type:JSON dict
class VirtualMicrobes.virtual_cell.Gene.MetabolicGene(reaction, substrates_ks=10.0, v_max=1.0, forward=True, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.Gene.Gene

Version:
Author:
ode_params()[source]

Returns a list of dictionaries of parameters necessary and sufficient to parameterize an ODE for all the sub-reactions associated with this Gene.

randomize_params(rand_gene_params, rand_generator)[source]
reaction
simple_str()[source]
toJSON(*args, **kwargs)[source]

Create JSON representation of gene.

Parameters:attr_mapper (dict) – mapping from properties to colours
Returns:
Return type:JSON dict
class VirtualMicrobes.virtual_cell.Gene.Promoter(pr_str, time_birth=0, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.PhyloUnit.PhyloBase

A promoter sequence object.

A promoter is exclusively associated with a genomic element. It encodes a basal promoter strength that is a factor in the gene expresion level.

mutate(mut_modifier, rand_gen)[source]

Mutates the promoter.

Parameters:
  • mut_modifier (func) – a function that changes the promoter parameters.
  • rand_gen (RNG) –
randomize(rand_gene_params, rand_generator)[source]

Randomize the promoter parameters.

Parameters:
  • rand_gene_params (dict) – parameters for the randomization function
  • rand_generator (RNG) –
strength
toJSON(attr_mapper, *args, **kwargs)[source]

Creates JSON representation of promoter.

Parameters:attr_mapper (dict) – mapping from attributes to colors
Returns:
Return type:A JSON dictionary.
uid = 0
class VirtualMicrobes.virtual_cell.Gene.TranscriptionFactor(ligand_mol_class, ligand_ks=10.0, ligand_cooperativity=1.0, binding_seq_len=10, binding_seq=None, eff_apo=1.0, eff_bound=1.0, k_bind_op=1.0, binding_cooperativity=2, sense_external=False, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.Gene.Gene

Version:
Author:
binding_sequence
init_ligand(ligand_class, ligand_ks=10)[source]

Set ligand class and the kinetic (K) constants of binding affinity for individual molecule species.

Parameters:
ligand_class
randomize(rand_gene_params, rand_gen, **kwargs)[source]

Randomizes gene properties.

Parameters:
  • rand_gene_params (dict) – parameters of randomization function
  • rand_gen (RNG) –
randomize_good_params(rand_gene_params, rand_generator)[source]
randomize_params(rand_gene_params, rand_generator)[source]
simple_str()[source]
toJSON(*args, **kwargs)[source]

Create JSON representation of gene.

Parameters:attr_mapper (dict) – mapping from properties to colours
Returns:
Return type:JSON dict
class VirtualMicrobes.virtual_cell.Gene.Transporter(reaction, ene_ks=10.0, substrates_ks=10.0, v_max=1.0, exporting=False, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.Gene.Gene

Transporter gene class.

Transporters can transport metabolites across the cell membrane. The class defines the kinetic parameters of the transport reaction. The exporting parameter determines the direction of transport.

Parameters:
  • reaction (VirtualMicrobes.virtual_cell.event.Reaction.Reaction) – the transport reaction of the gene
  • ene_ks (float or list of floats) – energy molecule binding constant
  • subtrate_ks (float or list of floats) – substrate binding constants
  • v_max (float) – max reaction flux constant
  • exporting (bool) – if true, set to exporting
ode_params()[source]

Returns a list of dictionaries of parameters necessary and sufficient to parameterize an ODE for all the sub-reactions associated with this Gene.

randomize_params(rand_gene_params, rand_generator, rand_direction=False)[source]

Randomizes gene properties.

Parameters:
  • rand_gene_params (dict) – parameters of randomization function
  • rand_generator (RNG) –
  • rand_direction (bool) – if true, randomize the direction of transport
reaction
simple_str()[source]
toJSON(*args, **kwargs)[source]

Create JSON representation of gene.

Parameters:attr_mapper (dict) – mapping from properties to colours
Returns:
Return type:JSON dict
VirtualMicrobes.virtual_cell.Gene.convert_rates(enzyme, enzyme_conc, metabolite_conc_dict)[source]

Estimate of conversion rates per substrate

Parameters:
  • enzyme – enzyme gene
  • enzyme_conc – internal enzyme concentrations
  • metabolite_conc_dict – concentrations of metabolites
VirtualMicrobes.virtual_cell.Gene.init_molecule_ks(mol_class, mol_ks, external=False)[source]

Initialize the ordered mapping from molecules to Ks.

Each molecule in a moleculeclass has an associated K value, that is the binding affinity.

Parameters:
Returns:

Return type:

mapping from VirtualMicrobes.event.Molecule.Molecule to K values (float)

VirtualMicrobes.virtual_cell.Gene.init_substrates_ks(reaction, kss)[source]

Initialize the ordered mapping from substrate molecules to Ks for a Conversion reaction.

Each molecule in a moleculeclass has an associated K value, that is the binding affinity.

Parameters:
  • reaction (VirtualMicrobes.event.Reaction.Conversion) –
  • mol_ks (float or list) – the K values for individual molecules
Returns:

Return type:

mapping from VirtualMicrobes.event.Molecule.Molecule to K values (float)

VirtualMicrobes.virtual_cell.Gene.pump_rates(pump, pump_conc, metabolite_conc_dict)[source]

Estimate of pumping rates for each substrate

Parameters:
  • pump – pump gene
  • pump_conc – internal pump concentration
  • metabolite_conc_dict – concentrations of metabolites
VirtualMicrobes.virtual_cell.Gene.random_gene(environment, rand_gene_params, rand_gen, params, keep_transport_direction=True)[source]
VirtualMicrobes.virtual_cell.Gene.randomized_param(rand_gene_params, rand_generator)[source]
VirtualMicrobes.virtual_cell.Gene.read_gene(environment, gene, gene_index, verbose=False)[source]
VirtualMicrobes.virtual_cell.Genome module
class VirtualMicrobes.virtual_cell.Genome.Genome(chromosomes, min_bind_score)[source]

Bases: object

add_chromosome(chrom, verbose=False)[source]

Add a chromosome to the list of chromosomes.

binding_sequences
binding_tfs_scores(op)[source]

Return tfs that bind this operator and their scores.

Parameters:op (VirtualMicrobes.virtual_cell.Sequence.Operator) – operator sequence
Returns:
Return type:list of VirtualMicrobes.virtual_cell.Gene.TranscriptionFactor, float tuples
bs_to_tfs_dict()[source]

Create mapping from binding sequences to tfs.

For each binding sequence in the genome map to the set of tfs that contain this binding sequence

Returns:
class_version = '1.0'
copy_number_dist
copy_numbers
copy_numbers_eff_pumps
copy_numbers_enzymes
copy_numbers_inf_pumps
copy_numbers_tfs
del_chromosome(chrom, remove_genes=True, verbose=False)[source]

Delete a chromosome.

Remove a chromosome from the list of chromosomes. If remove_genes is True the genome will be further updated to reflect deletion of genes. E.g. the sequence bindings should be updated when genes are removed from the genome. It may be useful to defer updating if it is already known that the genes will be readded immediately. This may be the case when a chromosome is split (fission) or fused and no genes will be actually lost from the genome.

Parameters:
die(time)[source]

Record death of phylogenetic units in the genome.

Typically called from the cell when it dies. All phylogenetic units in the genome are instructed to record their death. When phylogenetic units are no longer alive, they may be pruned from their respective phylogenetic trees if there are no more living descendants of the phylogenetic unit.

Parameters:time (float) – simulation time
eff_pumps
enzymes
inf_pumps
init_chromosomes(chromosomes)[source]

Initialize chromosomes.

Add preinitialized chromosomes to the genome.

Parameters:chromosomes (iterable of VirtualMicrobes.virtual_cell.Chromosome.Chromosome) – chromosomes to add
init_regulatory_network(min_bind_score)[source]

Initialize the binding state of the regulatory network.

Iterate over all :class:`VirtualMicrobes.virtual_cell.Sequence.Operator`s in the genome and match them against all :class:`VirtualMicrobes.virtual_cell.Sequence.BindingSequence`s.

Parameters:min_bind_score (float) – minimum binding score for sequence matching
op_to_tfs_scores_dict()[source]

Create mapping from operators to the tfs that bind them, with their scores.

For each operator in the genome map the set of tfs, together with their binding scores.

Returns:
operators
prune_genomic_ancestries()[source]

Prune the phylogenetic trees of phylogenetic units in the genome.

Returns:
pumps
reset_regulatory_network(min_bind_score)[source]

Reset the binding state of the regulatory network.

Iterate over all Sequences in the genome and clear all bindings. Then re-initialize the regulatory network.

Parameters:min_bind_score (float) – minimum binding score for sequence matching
size
tf_connections_dict()[source]

A dictionry of TFs to sets of downstream bound genes.

tfs
toJSON(*args, **kwargs)[source]
update(state)[source]
update_genome_removed_gene(gene)[source]

Remove a gene from the genome if no more copies exist in the genome.

Updates the genome

Parameters:gene (VirtualMicrobes.virtual_cell.GenomicElement.GenomicElement) – gene to be removed
update_genome_removed_genes(genes)[source]

Update the genome to reflect gene deletions.

After the deletion of (part of) a chromosome, the genome has to be updated to reflect the change. Because exact copies of deleted genes may still be present in another part of the genome a check has to be performed before definitive removal.

Parameters:genes (iterable of VirtualMicrobes.virtual_cell.GenomicElement.GenomicElement) – genes that were targeted by a deletion operation.
update_regulatory_network(min_bind_score)[source]

Update the binding state of the regulatory network.

Iterate over all Sequences in the genome and if their check_binding flag is set, match the sequence against all potential binders in the genome.

Parameters:min_bind_score (float) – minimum binding score for sequence matching
upgrade()[source]
VirtualMicrobes.virtual_cell.GenomicElement module
class VirtualMicrobes.virtual_cell.GenomicElement.GenomicElement(time_birth=0, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.PhyloUnit.PhyloBase

Version:
Author:
types = ['tf', 'pump', 'enz']
uid = 0
VirtualMicrobes.virtual_cell.Identifier module
class VirtualMicrobes.virtual_cell.Identifier.Identifier(obj, versioned_id=1, increment_func=None)[source]

Bases: object

clear_offspring()[source]
classmethod count_class_types(obj)[source]
from_parent(parent, flat=True, pos=-1)[source]

Set an Identifier from a parent id.

If id is incremented in a ‘flat’ way, the new id is the unique count of objects of the (parent) type that this id belongs to. Else, the id increment is done in a ‘versioned’ manner. If parent has 0 offspring ids so far, the parent id is simply copied and no increment is done. If parent already has > 0 offspring ids, then a version element is added that indicates this id as the “n’th” offspring of the parent id. E.g. if parent id is 2.3 and it has 2 offspring already: from_parent(parent, flat=False) -> 2.3.2

Parameters:
  • parent (object with an Identifier attribute) – The parent of this Identifier.
  • flat (bool) – If True, set versioned id position as the total number of counted objects of a the type of parent. Else, add versioned id information.
  • pos (int (index)) – index of the version bit to update
increment_func
increment_offspring()[source]
is_copy(identifier)[source]

Test if identifier and self are different copies of the same major_id.

identifier : Identifier
Identifier to compare to.
Returns:
Return type:bool
major_id

Return the first part (highest order) of identifier.

Returns:
Return type:int (or other id format)
minor_id

Return version part of the identifier.

Returns:
Return type:list of int (or other id format)
offspring_count
parse(versioned_id)[source]
unique_unit_dict = {}
versioned_id
VirtualMicrobes.virtual_cell.Identifier.increment(x)[source]
VirtualMicrobes.virtual_cell.PhyloUnit module
class VirtualMicrobes.virtual_cell.PhyloUnit.AddInheritanceType[source]

Bases: type

A metaclass that can set a class instances base type to support phylogenetic linking

The base type of the instantiated class can be either a PhyloBase or a PhyloUnit, depending on its _phylo_type class attribute. This enables an at run-time decision (via a program options) to fix the ancestry structure the class supports. PhyloBase instances keep references to neither parents nor children and hence do not need use a linker dict or unique_key generator. PhyloUnit does support ancestry. Phylogenetic linking is delegated to a global linker dict.

class VirtualMicrobes.virtual_cell.PhyloUnit.PhyloBase(time_birth)[source]

Bases: object

Base class for all classes that can behave as phylogenetic units of inheritance.

Phylogenetic Base units record their time of birth and death and have an identifier field that can indicate a relation to parents and offspring. PhyloBase object may come into existence when a mother cell gives rise to a daughter cell and all units of inheritance that it contains (i.e. when a genome get’s copied), but also when a phylogenetic unit (such as a gene or chromosome) mutates and the ancestral version will be kept intact for analysis purposes.

alive
die(time)[source]

Death of a phylo unit happens either when a cell dies and all its genetic material with it, or when a mutation gives rise to a new variant of the unit.

Parameters:time – Time of death in simulation time units.
id
living_offspring()[source]
mark(marker, mark)[source]

Set a marker on the phylo unit.

Parameters:
  • marker – marker type
  • mark – value
marker_dict
prune_dead_branch()[source]

Return self to be removed from the global phylo linker dict if not alive.

This is the degenerate base version of pruning. See the version in Phylo Unit for the case when units keep track of parent-child relationships.

time_birth
time_death
class VirtualMicrobes.virtual_cell.PhyloUnit.PhyloUnit(time_birth)[source]

Bases: VirtualMicrobes.virtual_cell.PhyloUnit.PhyloBase

Extended Base class for all classes that can be represented in phylogenies. These classes should support ancestor and child retrieval and setting time of birth and death.

child_of(phylo_unit)[source]

Return whether this PhyloUnit is the child of another PhyloUnit.

phylo_unit : PhyloUnit

children
common_ancestors(phylo_unit)[source]
die(*args, **kwargs)[source]

Death of a phylo unit happens either when a cell dies and all its genetic material with it, or when a mutation gives rise to a new variant of the unit.

Parameters:time – Time of death in simulation time units.
has_living_offspring(exclude_set=set([]), depth=1)[source]

Returns True if any of the phylo units descendants are alive

init_phylo_dicts()[source]
living_offspring()[source]

Returns a list of all offspring of this phylo unit that are currently alive.

lod_down_single()[source]

Proceed down a single branch on the line of descent until there is a branch point or terminal node.

lod_up_single()[source]

Proceed up a single branch on the line of descent until there is a branch point or terminal node.

lods_down()[source]

Composes all the lines of descent leading down (forward in time) from phylo unit in a non- recursive way (compare lods_up).

lods_up()[source]

Composes all the lines of descent leading up (back in time) from phylo unit (compare lods_down).

parent_of(phylo_unit)[source]

Return whether this PhyloUnit is the parent of another PhyloUnit.

phylo_unit : PhyloUnit

parents
prune_dead_branch(exclude_offspring_check_set=set([]), depth=1)[source]

Return a set of phylogenetically related units that represent a dead phylogenetic branch.

Recursively checks for parent nodes whether the nodes descendants are all dead. In that case, the node can be pruned and its parents may additionally be checked for being part of the extended dead branch. The exclude is used to prevent superfluous checks of living offspring when it is already known that the current phylo_unit has no living_offspring.

Parameters:exclude_offspring_check_set (set of VirtualMicrobes.virtual_cell.PhyloUnit.PhyloUnit) –
set_ancestor(ge)[source]
set_unique_key()[source]

Generate a unique key that can be used for mapping in a global linker dict.

VirtualMicrobes.virtual_cell.Population module
class VirtualMicrobes.virtual_cell.Population.Population(params, environment)[source]

Bases: object

add_cell(cell)[source]

Add an individual to the population.

A cell that is added is stored in a dictionary that maps the individual to a dictionary of properties, e.g. the numer of offspring.

Increase the population size.

Parameters:cell (VirtualMicrobes.virtual_cell.Cell.Cell) – the individual to add
ages(cells=None)[source]

Return array of individual death rate parameters.

average_death_rate(cells=None)[source]
average_production(cells=None)[source]
average_promoter_strengths(cells=None)[source]

Return array of individual average genomic promoter strength.

best_producer()[source]

Return the individual and the value of highest production in the population.

calculate_death_rates(base_death_rate=None, max_die_off_fract=None, death_rate_scaling=None, toxicity_scaling=None, no_death_frac=None, cells=None)[source]

Calculate and store death rates of individuals.

Uses a base_death_rate and toxicity_scaling parameter to calculate the death rate of individuals.

Parameters:
  • base_death_rate (float, optional) – base death rate for all individuals
  • max_die_off_fract (float, optional) – maximum fraction of individuals that can die (stochastically)
  • toxicity_scaling (float, optional) – scaling parameter for toxicity death rate effect
  • cells (sequence of VirtualMicrobes.virtual_cell.Cell.Cell) – individuals in calculation
Returns:

Return type:

returns mapping of cells to death rates

calculate_reference_production(pressure=None, historic_production_weight=None)[source]

Calculates a reference production value for competition.

Reference production is used to scale the reproductive potential of cells during competition to reproduce.

Parameters:
  • pressure (str) – type of selection pressure scaling
  • historic_production_weight (float, optional) – weighting of historic production values
cell_death(cell, time, wiped=False)[source]

Kill an individual.

Updates the population size. Sets the time of death of individual.

Parameters:
cell_markers(marker, cells=None)[source]
cell_sizes(cells=None)[source]

Return array of individual cell volumes.

chromosomal_mut_counts(cells=None)[source]

Return array of individual counts of life time chromosomal mutations.

chromosome_counts(cells=None)[source]

Return array of individual chromosome counts.

class_version = '1.2'

A population of individual Cells that reproduce and die during a Simulation.

The class defines methods for life history events of the cell population:
  • death of individuals
  • competition and reproduction
  • population level gene exchange (HGT)

Phylogenetic relationships between individuals in the population are tracked and a phylogenetic tree is maintained and pruned when individuals reproduce and die.

Parameters:
  • params (dict) – a dictionary of simulation parameters
  • environment (VirtualMicrobes.environment.Environment) – environment that is home to the population; determines molecular and reaction universe
params

reference of Simulation parameters

Type:dict
historic_production_max

historic maximum of production value in the population

Type:float
production_val_history

history of all population production maxima

Type:list of floats
pop_rand_gen

RNG for drawing population events

Type:RNG
evo_rand_gen

RNG for drawing evolutionary events

Type:RNG
markers_range_dict

stores ranges for cell markers used in plotting

Type:dict
value_range_dict

ranges of attributes on phylogenetic tree

Type:dict
current_pop_size

population size

Type:int
died

individuals that have died in the current simulation step

Type:sequence of VirtualMicrobes.virtual_cell.Cell.Cell s
cell_dict

mapping from VirtualMicrobes.virtual_cell.Cell.Cell to attributes

Type:dict
cells

the living VirtualMicrobes.virtual_cell.Cell.Cell s in the population

Type:view on keys
new_offspring

individuals born in current time step

Type:sequence of VirtualMicrobes.virtual_cell.Cell.Cell s
pruned_cells

individuals that are dead and do not have living offspring

Type:set of VirtualMicrobes.virtual_cell.Cell.Cell s
current_ancestors

living individuals and ancestors that contribute offspring to current population

Type:sequence of VirtualMicrobes.virtual_cell.Cell.Cell s
roots

first common ancestors of current population

Type:sequence of VirtualMicrobes.virtual_cell.Cell.Cell s
phylo_tree

represent phylogenetic tree of current population

Type:VirtualMicrobes.Tree.PhyloTree.PhyloTree
pruned_cells

cell phylo units to be pruned from global phylo dict

Type:set of VirtualMicrobes.virtual_cell.PhyloUnit.PhyloUnit
pruned_chromosomes

chromosome phylo units to be pruned from global phylo dict

Type:set of VirtualMicrobes.virtual_cell.PhyloUnit.PhyloUnit
pruned_genes

gene phylo units to be pruned from global phylo dict

Type:set of VirtualMicrobes.virtual_cell.PhyloUnit.PhyloUnit
clear_mol_time_courses()[source]
clear_pop_changes()[source]

Reset population change containers.

cloned_pop(pop_size, environment, params_dict, time=0)[source]

Creates a single ancestor VirtualMicrobes.virtual_cell.Cell.Cell individual and initialises its genomes. Genome initialisation depends on the environment, because this determines the set of possible gene types and minimum viable metabolism that can be constructed.

The population is then generated by cloning the ancestor individual. Clones are identical and store a reference to the ancestor.

Parameters:
  • pop_size (int) – population size
  • environment (VirtualMicrobes.environment.Environment) – environment that is home to the population; determines molecular and reaction universe
  • params_dict (dict, optional) – a dictionary of simulation parameters
  • time (int, optional) – time of birth of the clone
Returns:

common ancestor – the common ancestor of the cloned population

Return type:

VirtualMicrobes.virtual_cell.Cell.Cell

cloned_pop_from_files(pop_size, environment, cell_files=None, time=0)[source]

Create population of individuals initialised from cell parameter files.

Creates VirtualMicrobes.virtual_cell.Cell.Cell individuals and reads their genome and state from cell parameter files.

Parameters:
  • pop_size (int) – population size
  • environment (VirtualMicrobes.environment.Environment) – environment that is home to the population; determines molecular and reaction universe
  • time (int, optional) – time of birth of the clone
Returns:

common_ancestors – the common ancestors of the new population

Return type:

list of VirtualMicrobes.virtual_cell.Cell.Cell objects

consumer_type_counts(cells=None)[source]

Return counts of cell sets with equal consumption metabolomes.

death_rates(cells=None)[source]

Return array of individual death rate parameters.

die_off(time, cells=None)[source]

Kill individual cells.

Individuals die deterministically if their cell volume is too low, or stochastically, with a probability : death_rate .

Parameters:
  • time (int) – simulation time
  • max_die_off_frac (float, optional) – maximum fraction of individuals that can die
  • min_cell_volume (float, optional) – minimum cell volume for survival
  • stochastic_death (bool, optional) – if true, cells die stochastically, according to a death_rate
  • cells (sequence of VirtualMicrobes.virtual_cell.Cell.Cell) – individuals that can die
differential_regulation(cells=None)[source]

Return array of individual average differential regulation value.

enz_average_promoter_strengths(cells=None)[source]

Return array of individual average enzyme promoter strength.

enzyme_average_vmaxs(cells=None)[source]

Return array of individual average enzyme vmax values.

enzyme_counts(cells=None)[source]

Return array of individual enzyme gene counts.

enzyme_substrate_ks(cells=None)[source]

Return array of individual average enzyme substrate binding strength values.

export_type_counts(cells=None)[source]

Return counts of cell sets with equal export genotypes

exporter_counts(cells=None)[source]

Return array of individual exporting pump gene counts.

genome_sizes(cells=None)[source]

Return array of individual genome sizes.

genotype_counts(cells=None)[source]

Return counts of cell sets with equal genotypes

get_cell_age_dict(cells=None)[source]

Return dict of cell sizes.

get_cell_death_rate_dict(cells=None)[source]
get_cell_divided_dict(cells=None)[source]

Return dict of cell sizes.

get_cell_genome_size_dict(cells=None)[source]
get_cell_pos_production_dict(cells=None)[source]

Return dict of cell production values.

get_cell_production_dict(cells=None, life_time_prod=None)[source]

Return a mapping of cells and their last or life time production value.

Parameters:
  • cells (sequence of Cell objects) – individuals to map, default is the current population
  • life_time_prod (bool) – take life time mean production instead of current
get_cell_production_rate_dict(cells=None)[source]

Return dict of cell production rates.

get_cell_reproduction_dict(cells=None)[source]

Counts of the number of reproduction events for each cell (living and dead direct children)

get_cell_size_dict(cells=None)[source]

Return dict of cell sizes.

get_cell_toxicity_rate_dict(cells=None)[source]

Return dict of cell toxicity change rates.

grow_time_course_arrays()[source]
hgt_neighs(cells=None)[source]

Return array of individual hgt neighbourhoods.

horizontal_transfer(time, grid, environment, rand_gen=None, rand_gen_np=None)[source]

Applies HGT to all cells in the grid

Parameters:
  • grid (needed for internal HGT and setting the update-flags) –
  • environment (contains all possible reactions to draw a random gene for external HGT) –
  • rand_gen (RNG) –
Returns:

Return type:

import_type_counts(cells=None)[source]

Return counts of cell sets with equal import genotypes

importer_counts(cells=None)[source]

Return array of individual importing pump gene counts.

init_cells_view()[source]

Initialise the view on the keys of the cell dict.

init_current_ancestors(cells=None)[source]

Initialise the current ancestors.

init_evo_rand_gens(evo_rand_seed=None)[source]

Initialise random generator for evolutionary events

init_phylo_tree(supertree=False)[source]

Initialise the phylogenetic tree of the population.

Parameters:supertree (bool, optional) – if true create supertree of all independent phylogenetic lineages
init_pop(environment, pop_size=None, params_dict=None)[source]

Initialise the population.

Population initialisation is determined by the set of simulation parameters available in the params_dict or the params stored during construction of the VirtualMicrobes.virtual_cell.Population.Population. Several methods for creating a population are available:

  • a new population of unique individuals is created with randomised

cell parameters. * individuals are initialised from a set of cell configuration files, describing their parameters * a population of identical clones is generated from a single randomly initialised individual.

Initialise the phylogenetic tree.

Parameters:
  • environment (VirtualMicrobes.environment.Environment) – environment that is home to the population; determines molecular and reaction universe
  • pop_size (int, optional) – size of population
  • params_dict (dict, optional) – a dictionary of simulation parameters
Returns:

the newly created individuals

Return type:

iterator of VirtualMicrobes.virtual_cell.Cell.Cell objects

init_pop_rand_gen(pop_rand_seed=None)[source]

Initialise random generator for population events

init_range_dicts()[source]

Initialise mappings used in colour coding individuals in graphical output.

The markers_range_dict stores lower and upper bounds on discrete population statistics.

The metabolic_type_marker_dict maps metabolic types to markers that are used for colour coding.

The value_range_dict stores lower and upper limits on various celll properties that are represented on the phylogenetic tree.

init_roots(roots=None)[source]

Initialise the phylogenetic roots.

If no roots are given, initialise roots with the current_ancestors.

Parameters:roots (sequence of VirtualMicrobes.virtual_cell.Cell.Cell, optional) – roots ancestors of the population
iterages(cells=None)[source]

Return array of individual line of descent ages.

kill_cells_lineage(lineages, time, fract, cells=None)[source]
lineages(cells=None)[source]

Return array of individual linages

make_anc_clones(generations_ago, density)[source]
make_cell_clones(environment, list_of_cell_files, density)[source]
mark_cells_lineage(cells=None)[source]
mark_cells_metabolic_type(cells=None)[source]
mark_for_death(max_die_off_frac=None, min_cell_volume=None, stochastic_death=None, cells=None)[source]

Kill individual cells.

Individuals die deterministically if their cell volume is too low, or stochastically, with a probability : death_rate .

Parameters:
  • time (int) – simulation time
  • max_die_off_frac (float, optional) – maximum fraction of individuals that can die
  • min_cell_volume (float, optional) – minimum cell volume for survival
  • stochastic_death (bool, optional) – if true, cells die stochastically, according to a death_rate
  • cells (sequence of VirtualMicrobes.virtual_cell.Cell.Cell) – individuals that can die
marker_counts(marker, cells=None)[source]
classmethod metabolic_complementarity(cells, strict_providing=False, strict_exploiting=False)[source]

Determine for the list of cells what the overlap is in metabolites provided and exploited.

To provide a metabolite a cell should simultaneous produce and export the metabolite. To exploit, it should be imported and consumed in a reaction.

metabolic_complementarity_pop(strict=False)[source]

Return the set of metabolites that are provided and exploited simultaneously by the population.

See also

func()
metabolic_complementarity
metabolic_type_color(cell)[source]
metabolic_type_counts(cells=None)[source]

Return frequencies of cell sets with identical metabolic types.

A metabolic type is defined on the bases of the full set of metabolic reactions that an individual can perform using its metabolic gene set. A frequency spectrum of these types is than produced in the form of a collections.Counter object. From this object we can ask things like: most_common(N) N elements etc.

metabolic_types(cells=None)[source]

Return array of individual metabolic types

most_abundant_marker(marker_name, cells=None)[source]
most_offspring()[source]

Return individual and value of highest offspring count.

mutate_new_offspring(time, gp_dict, environment, rand_gen=None, rand_gen_np=None)[source]
offspring_counts(cells=None)[source]

Return array of individual offspring counts.

oldest_cell()[source]

Return oldest living individual.

pan_reactome_dict(cells=None)[source]

Return the pan reactome of the population.

The pan-reactome is the combined set of reactions present in the population.

Returns:

Notes

For historic reasons the set of all transport reactions, either importing or exporting are keyd under ‘import’. This type as stored in the type_ attribute of the VirtualMicrobes.event.Reaction.Reaction and should not be confused with the type_ attribute of the :class:VirtualMicrobes.virtual_cell.Gene.Gene` object.

point_mut_counts(cells=None)[source]

Return array of individual counts of life time point mutations.

pop_marker_counts(marker_name, cells=None)[source]
pos_production(cells=None)[source]

Return array of individual positive production rates.

print_state()[source]

Print population state.

producer_type_counts(cells=None)[source]

Return counts of cell sets with equal production metabolomes.

production_rates(cells=None)[source]

Return array of individual netto production rates.

production_values(cells=None)[source]

Return array of individual production values.

prune_metabolic_types(cells=None)[source]
pump_average_promoter_strengths(cells=None)[source]

Return array of individual average pump promoter strength.

pump_average_vmaxs(cells=None)[source]

Return array of individual average pump vmax values.

pump_energy_ks(cells=None)[source]

Return array of individual average pump energy binding strength values.

pump_substrate_ks(cells=None)[source]

Return array of individual average pump substrate binding strength values.

reaction_counts(cells=None)[source]

Return counts of all reactions found in the population.

reaction_counts_split(cells=None)[source]

Return counts of all reactions found in the population per reaction type.

reaction_genotype_counts(cells=None)[source]

Return counts of cell sets with equal reaction genotypes

regulator_score(cells=None)[source]
reproduce_at_minimum_production(time, competitors=None, max_reproduce=None, reproduction_cost=None)[source]
reproduce_cell(cell, time, spent_production=0.0, report=False)[source]

Reproduction of individual cell.

Parameters:
  • cell (VirtualMicrobes.virtual_cell.Cell.Cell) – reproducing individual
  • time (int) – simulation time
  • spent_production (float, optional) – production spent on reproducing
  • report (bool, optional) – reporting
Returns:

offspring – new individual

Return type:

VirtualMicrobes.virtual_cell.Cell.Cell

reproduce_neutral(time, competitors, max_reproduce=None)[source]

Individuals compete and reproduce proportional to NOTHING :) Note that cells would shrink if you keep doing this! Therefore we choose to reset the volumes continuously.

Parameters:
Returns:

new_offspring – new offspring produced in this function

Return type:

list of VirtualMicrobes.virtual_cell.Cell.Cell s

reproduce_on_grid(grid, max_pop_per_gp, time, neighborhood='competition', non=None, selection_pressure=None)[source]

Reproduction of the population on the spatial grid.

Parameters:
  • grid (VirtualMicrobes.Environment.Grid.Grid) – spatial grid environment
  • max_pop_per_gp (int) – maximum number of individuals per grid point
  • time (int) – simulation time
  • neighborhood (str, optional) – key to select neighborhood shape
  • non (float, optional) – chance of no competitor winning competition
  • selection_pressure (str) – type of selection pressure
Returns:

new_offspring_gp_dictVirtualMicrobes.environment.Grid.GridPoint mapping of new offspring to the spatial grid point that they are born in.

Return type:

VirtualMicrobes.virtual_cell.Cell.Cell ->

reproduce_production_proportional(time, competitors, max_reproduce=None, production_spending_fract=None, non=0.0)[source]

Individuals compete and reproduce proportional to their production value.

Parameters:
  • time (int) – simulation time
  • competitors (list of VirtualMicrobes.virtual_cell.Cell.Cell) – competing individuals
  • max_reproduce (int, optional) – maximum allowed reproduction events
  • production_spending_fract (float, optional) – fraction of cell production value spent on reproduction
  • non (float, optional) – chance of no competitor winning competition
Returns:

new_offspring – new offspring produced in this function

Return type:

list of VirtualMicrobes.virtual_cell.Cell.Cell s

reproduce_size_proportional(time, competitors, max_reproduce=None, non=0.0)[source]

Individuals compete and reproduce proportional to their cell size.

Parameters:
  • time (int) – simulation time
  • competitors (list of VirtualMicrobes.virtual_cell.Cell.Cell) – competing individuals
  • max_reproduce (int, optional) – maximum allowed reproduction events
  • non (float, optional) – chance of no competitor winning competition
Returns:

new_offspring – new offspring produced in this function

Return type:

list of VirtualMicrobes.virtual_cell.Cell.Cell s

reset_divided()[source]

Reset flag for recent cell division.

reset_production_toxicity_volume(cells=None)[source]
resize_time_courses(new_max_time_points)[source]

resize the arrays that can hold time course information of cellular concentrations etc.

Parameters:new_max_time_points – new length of time course array
scale_death_rates(max_die_off_fract, cells=None)[source]

Scale death rates to give a maximum rate of dieing individuals.

If individual death rate are too high, these are scaled to have a maximum fraction of deaths, on average, in the population.

Parameters:
Returns:

Return type:

returns mapping of cells to death rates

select_reproducing_cell(cells_competition_value, rand_nr, non=0.0, competition_scaling_fact=None)[source]

Select a competing individual for reproduction.

Parameters:
  • cells_competition_value (list of (class:VirtualMicrobes.virtual_cell.Cell.Cell, float)) – competing cells with competition values
  • rand_nr (float) – randomly drawn value between 0 and 1.
  • non (float, optional) – value between 0 and 1 that represents no individual is chosen
  • competition_scaling_fact (float, optional) – factor that can skew competition to be more or less severe
Returns:

Return type:

(chosen individual, competition_value, index in competition list)

store_pop_characters()[source]
tf_average_promoter_strengths(cells=None)[source]

Return array of individual average transcription factor promoter strength.

tf_counts(cells=None)[source]

Return array of individual transcription factor gene counts.

tf_k_bind_operators(cells=None)[source]

Return array of individual average transcription factor operator binding strength values.

tf_ligand_ks(cells=None)[source]

Return array of individual average transcription factor ligand binding strength values.

times_divided(cells=None)[source]

Return array of individual death rate parameters.

toxicity_rates(cells=None)[source]

Return array of individual toxicity change rates.

trophic_type_counts(env, cells=None)[source]

Return counts of trophic types in the population.

unique_pop(pop_size, environment, params_dict)[source]

Create population of unique, randomised individuals.

Creates new class:VirtualMicrobes.virtual_cell.Cell.Cell individuals and initialises their genomes. Genome initialisation depends on the environment, because this determines the set of possible gene types and minimum viable metabolism that can be constructed.

Parameters:
  • pop_size (int) – population size
  • environment (VirtualMicrobes.environment.Environment) – environment that is home to the population; determines molecular and reaction universe
  • params_dict (dict, optional) – a dictionary of simulation parameters
Returns:

the newly created individuals

Return type:

view keys of VirtualMicrobes.virtual_cell.Cell.Cell objects

update_cell_params(cells=None)[source]

Update the the cell parameters.

Sets cell parameters from the Simulation params dict.

Parameters:cells (sequence of VirtualMicrobes.virtual_cell.Cell.Cell, optional) – the cells to update
update_ete_tree()[source]

Update the ete tree representation of the phylo_tree.

update_lineage_markers(cells=None, min_nr_marks=None)[source]
update_offspring_regulatory_network(min_bind_score=None)[source]
update_phylogeny(new_roots=None, verbose=True, add_living=None)[source]

Update the phylogeny of the current population.

current_ancestors contains all living individuals and those that have contributed to the current population.

Individuals are only added to the phylo_tree representation after they have died, unless the add_living option is used. Nodes will only remain in the phylo_tree as long as the branch they’re on contains a living individual in the current population. If a lineage dies out, its corresponding branch (and its constituent tree nodes) is pruned from the phylogenetic tree.

  • Add new offspring to the current ancestors.
  • Prune extinct branches in the phylogeny and remove ancestors without living offspring
  • Update the phylogenetic tree structure:
    • add new root nodes
    • add new intermediate nodes
    • prune dead branches and nodes
Parameters:
Returns:

phylo_tree – phylogenetic tree representation of current population

Return type:

VirtualMicrobes.Tree.PhyloTree.PhyloTree

update_prod_val_hist(hist_prod_func=<function median>, historic_production_window=None, pop_size_scaling=None)[source]

Keep a sliding window view on historic production values.

Parameters:
  • hist_prod_func (func, optional) – calculates the population production value
  • historic_production_window (int, optional) – length of the sliding window
  • pop_size_scaling (bool, optional) – scale production value by population size
update_stored_variables()[source]

Syncs all local variables of class Cell.py (small_molecules) with the time course data

upgrade()[source]

Upgrading from older pickled version of class to latest version. Version information is saved as class variable and should be updated when class invariants (e.g. fields) are added.

uptake_rates(cells=None)[source]

Return array of individual uptake multipliers.

wipe_pop(fract, time, min_surv=None, cells=None)[source]

Kill a fraction of the individuals.

Sets a flag on individuals that were killed by wipe_pop.

Parameters:
  • fract (float) – fraction to kill
  • time (int) – simulation time
  • min_surv (int, optional) – minimum number of surviving individuals
  • cells (sequence of VirtualMicrobes.virtual_cell.Cell.Cell) – individuals in calculation
Returns:

Return type:

list of individuals that were killed

VirtualMicrobes.virtual_cell.Sequence module
class VirtualMicrobes.virtual_cell.Sequence.BindingSequence(sequence=None, length=None, elements=['0', '1'], flip_dict={'0': '1', '1': '0'}, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.Sequence.Sequence

Binding sequence of a Transcription Factor

bound_operators
clear_bound_operators()[source]
inform_operators()[source]
init_bound_operators()[source]
match_operators(operators, minimum_score)[source]
remove_bound_operator(op)[source]
toJSON(*args, **kwargs)[source]
class VirtualMicrobes.virtual_cell.Sequence.Operator(sequence=None, length=None, elements=['0', '1'], flip_dict={'0': '1', '1': '0'}, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.Sequence.Sequence

Version:
Author:
bind_to_bs(bs, minimum_score, report=False)[source]
binding_sequences
calc_score_for_bs(binding_site, minimum_score=1.0, report=False)[source]
calculate_regulation()[source]
clear_binding_sequences()[source]
inform_bss()[source]
init_binding_sequences()[source]

A dictionary from binding sequences that bind to this operator to binding scores

remove_binding_sequence(bs)[source]
toJSON(*args, **kwargs)[source]
update_binding_sequences(all_binding_sequences, minimum_score)[source]

Find the Binding Sequences that match this Operator and update dictionaries accordingly. Matching depends on a threshold “minimum_score”.

Parameters:
  • binding_sequences – set of BS
  • minimum_score – threshold for calling a match between this

Operator and a BS

class VirtualMicrobes.virtual_cell.Sequence.Sequence(sequence, elements, length, flip_dict, time_birth=0, **kwargs)[source]

Bases: VirtualMicrobes.virtual_cell.PhyloUnit.PhyloBase

Version:
Author:
best_match(s2, at_least=0, penalty=0.5, report=False)[source]

Finds the best match possible between self and s2 anywhere in both sequences, but only if the match score reaches at least a minimum threshold. If the returned score is below this threshold it is not guaranteed to be the best possible match. No gaps are allowed.

Parameters:
  • s2 – sequence to compare to
  • at_least – the minimum score that should still be attainable by

the scoring algorithm for it to proceed computing the scoring matrix :param penalty: mismatch penalty

bit_flip(bit, flip_dict=None)[source]
check_binding
elements
flip_dict
insert_mutate(pos, sequence_stretch, constant_length=True)[source]

Insert a sequence stretch into the current sequence.

Sets the check_binding flag to indicate that the sequence should be checked for changed binding status.

Parameters:
  • pos (int) – position in current sequence to insert
  • sequence_stretch (str) – stretch to be inserted
  • constant_length (bool) – whether to truncate after insertion to maintain the original sequence length
Returns:

Return type:

newly mutated sequences

match(sequence, func)[source]
mutate(rand_gen=None, change_magnitude=None)[source]

Mutates the sequence.

Number of bits to mutate is either 1 or an amount of bits determined by the probability per bit to be changed or a given number of bits, depending on the value of “change_magnitude”. Sets the check_binding flag to indicate that the sequence should be checked for changed binding status.

Parameters:
  • rand_gen (RNG) –
  • change_magnitude (float or int) – when < 1, it is a probability, otherwise it is assumed to be the number of bits that should be changed (rounded up to nearest integer).
Returns:

Return type:

newly mutated sequences

mutate_bits(nr=1, rand_gen=None)[source]

Mutates a given number of random bits in the sequence to new values, chosen from the set of elements (possible values) that a bit can take, randomly.

Parameters:
  • nr – number of bits to mutate
  • rand_gen – random generator
random_sequence(n, rand_gen)[source]

Create random sequence of length n from elements.

Parameters:
  • n (int) – length of sequence
  • rand_gen (RNG) –
Returns:

Return type:

sequence string

randomize(rand_gen=None)[source]
sequence
classmethod substring_scoring_matrix(s1, s2, at_least=0, penalty=0.5)[source]

Computes a scoring matrix for matching between 2 sequences. Starts with a matrix filled in with all -1 . Comparisons between the strings continue as long as it is still possible to obtain the ‘at_least’ score when comparing the remainder of the strings. When the score is too low and the remaining substring length that can still be matched too short, the algorithm will stop, leaving the rest of the scores uncomputed. In that case, the _max is not guaranteed to be the maximum attainable matching score.

example matrix when matching sequences 0000000000 and 0000010100 with the default mismatch penalty of 0.5 (penalty substracted from score attained up to that point).

0 0 0 0 0 0 0 0 0 0 <- sequence 1

0 0 0 0 0 0 0 0 0 0 0

0 0 1 1 1 1 1 1 1 1 1 1 0 0 1 2 2 2 2 2 2 2 2 2 0 0 1 2 3 3 3 3 3 3 3 3 0 0 1 2 3 4 4 4 4 4 4 4 0 0 1 2 3 4 5 5 5 5 5 5 1 0 0 0.5 1.5 2.5 3.5 4.5 4.5 4.5 4.5 4.5 0 0 1 1 1.5 2.5 3.5 4.5 5.5 5.5 5.5 5.5 1 0 0 0.5 0.5 1.0 2.0 3.0 4.0 5.0 5.0 5.0 0 0 1 1 1.5 1.5 2.0 3.0 4.0 5.0 6.0 6.0 0 0 1 2 2 2.5 2.5 3.0 4.0 5.0 6.0 7.0

sequence 2

sequence 1: 0000000000 sequence 2: 0000010100 match: 0.7

uid = 0
VirtualMicrobes.virtual_cell.Sequence.pretty_scoring_matrix(seq1, seq2, scoring_mat, width=4)[source]
Module contents

Module contents

Created on Aug 26, 2016 Modified in November, 2018* @author: thocu @author2: brem*

Glossary

building block
A metabolite that is used by microbes to produce biomass. Biomass production may depend on the simultaneous conversion of a set of building blocks.
LOD
The line of descent is the genealogical succession of individuals that connects some ancestor with one of its descendants. In the model these are constructed by storing all parent-offspring relations.
metabolite
Any molecule that are not enzymes and that can undergo a reaction, including influx and degradation reactions.

CHANGELOG

nothing changed here

Contributing

Contributions are welcome, and they are greatly appreciated! Every little bit helps, and credit will always be given.

Bug reports

When reporting a bug please include:

  • Your operating system name and version.
  • Any details about your local setup that might be helpful in troubleshooting.
  • Detailed steps to reproduce the bug.

Documentation improvements

VirtualMicrobes could always use more documentation, whether as part of the official SampleProject docs, in docstrings, or even on the web in blog posts, articles, and such.

Feature requests and feedback

The best way to send feedback is to file an issue at https://bitbucket.org/thocu/virtualmicrobes/issues.

If you are proposing a feature:

  • Explain in detail how it would work.
  • Keep the scope as narrow as possible, to make it easier to implement.
  • Remember that this is a volunteer-driven project, and that code contributions are welcome :)

Development

To set up VirtualMicrobes for local development:

  1. Fork VirtualMicrobes (look for the “Fork” button).

  2. Clone your fork locally:

    git clone https://thocu@bitbucket.org/thocu/virtualmicrobes.git
    
  3. Create a branch for local development:

    git checkout -b name-of-your-bugfix-or-feature
    

    Now you can make your changes locally.

  4. When you’re done making changes, run all the checks, doc builder and spell checker with tox one command:

    tox
    
  5. Commit your changes and push your branch to GitHub:

    git add .
    git commit -m "Your detailed description of your changes."
    git push origin name-of-your-bugfix-or-feature
    
  6. Submit a pull request through the GitHub website.

Pull Request Guidelines

If you need some code review or feedback while you’re developing the code just make the pull request.

For merging, you should:

  1. Include passing tests (run tox) [1].
  2. Update documentation when there’s new API, functionality etc.
  3. Add a note to CHANGELOG.rst about the changes.
  4. Add yourself to AUTHORS.rst.
[1]

If you don’t have all the necessary python versions available locally you can rely on Travis - it will run the tests for each change you add in the pull request.

It will be slower though …

Tips

To run a subset of tests:

tox -e envname -- py.test -k test_myfeature

To run all the test environments in parallel (you need to pip install detox):

detox

Authors

  • Thomas Detmer Cuypers - Bram van Dijk

Project repository

on bitbucket