Skip to main content
bioRxiv
  • Home
  • About
  • Submit
  • ALERTS / RSS
Advanced Search
New Results

Spring Model – chromatin modeling tool based on OpenMM

Michal Kadlof, Julia Rozycka, View ORCID ProfileDariusz Plewczynski
doi: https://doi.org/10.1101/642322
Michal Kadlof
Centre of New Technologies, University of Warsaw, S. Banacha 2c, 02-097 Warsaw, PolandFaculty of Physics, University of Warsaw, Pasteura 5, 02-093 Warsaw, Poland
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Julia Rozycka
Centre of New Technologies, University of Warsaw, S. Banacha 2c, 02-097 Warsaw, PolandFaculty of Mathematics, Informatics and Mechanics, University of Warsaw, Banacha 2, 02-097 Warsaw, Poland
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Dariusz Plewczynski
Centre of New Technologies, University of Warsaw, S. Banacha 2c, 02-097 Warsaw, PolandFaculty of Mathematics and Information Science, Warsaw University of Technology, Koszykowa 75, 00-662 Warsaw, Poland
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
  • ORCID record for Dariusz Plewczynski
  • For correspondence: d.plewczynski@cent.uw.edu.pl
  • Abstract
  • Full Text
  • Info/History
  • Metrics
  • Data/Code
  • Preview PDF
Loading

Abstract

Chromatin structures modelling is a rapidly developing field. Parallel to the enormous growth of available experimental data, there is a growing need of building and visualizing 3D structures of nuclei, chromosomes, chromatin domains, and single loops associated with particular genes locus. Here we present a tool for chromatin domain modeling. It is available as a webserver and standalone python script. Our tool is based on molecular mechanics. It uses OpenMM engine for building models. In this method, the user has to provide contacts and will obtain 3D structure that satisfies these contacts. Additional extra parameters allow controlling fibre stiffness, type of initial structure, resolution. There are also options for structure refinement, and modelling in a spherical container. A user may provide contacts using beads indices, or paste interactions in genome coordinates from BEDPE file. After modelling user is able to download the structure in Protein Data Bank (PDB) file format for further analysis.

We dedicate this tool for all who are interested in chromatin structures. It is suitable for quick visualization of datasets, studying the impact of structural variants (SVs), inspecting the effects of adding and removing particular contacts, measuring features like maximum distances between certain sites (e.g. promotor-enhancer) or local density of chromatin.

1. Introduction

Nowadays we observe an enormous increase of interest in the 3D chromatin structure. Novel techniques based on chromosome conformation capture (3C) technology, like Hi-C or Chromatin Interaction Analysis by Paired-End Tag Sequencing (ChIA-PET) provided a great amount of data related to internal contacts, with great resolution, up to ∼1 kbp[1–4]. Since the first data sets appeared, there have been efforts to extract relevant biological information from them, using various bioinformatic and statistical techniques[5]. At the same time, many scientists have tried to determine the exact internal structure of the nucleus for multiple reasons. The most importantly obtaining a model that can explain observable data is confirmation of deep understanding of biological mechanism ruling a structure. Secondly a proper 3D model will be able to predict the effects of SVs and mutation effects, and in future directly connect the structure changes with gene expression levels. Thirdly 3D models are useful for visualization of studied regions..

Multiple modeling techniques have appeared, based on different assumptions, backed up by different theories. One of the earliest modern models of chromatin was based o Grossberg’s[6] crumpled globule, and recapitulated by Mirny in his studies on fractal globules as chromatin models[7]. A completely different approach was applied in [8, 9] where authors employed multidimensional scaling (MDS) on transformed Hi-C maps. The idea behind this technique is that, if we have matrix with distances (similarities) between points, we can distribute these points in 3D space to satisfy these distances. It is like getting a map with positions of cities just from a table of distances between them. However transforming Hi-C matrices into distances is a non-trivial task.

Another group of methods, based on the observation that chromatin loops in Bilateria animals cells are formed in presence of some mediators. One of the most frequently mentioned is CCCTC-binding factor (CTCF) also known as 11-zinc finger protein. In this approach the loop is the primary element of model. In the loop-extrusion-model the chromatin fiber is dynamically extruded through a ring of cohesin and stops after meeting a CTCF motif with the necessary orientation[10]. Another model was developed by group led by Mario Nicodemi called the String-and-Binders-Switch model (SBS), in which chromatin fiber is surrounded by free floating binders that may interact with certain sites on the fiber thus making it stick together[11]. Another Monte Carlo method based directly on ChIA-PET PET clusters is 3D-GNOME, and is implemented as a webserver [12]. Last, but not least, it is worth-while to mention the Maximum Entropy model, which finds an ensemble of chromosome conformations consistent with a pseudo-Boltzmann distribution for an energy landscape that reproduces the experimentally measured pairwise contact frequencies from Hi-C maps[13].

In this paper we introduce another chromatin conformation modeling tool – Spring Model (SM), a fast, simple to use and powerful tool for visualisation of a fiber with a given set of contacts, in 3D space. We dedicate this tool for everyone who would like to analyse their region-of-interests (ROI) from a structural perspective. It allows one to observe, how a structure will change after adding or removing some interaction sites, simulating effects of structural variants (SVs), and thus observing how changes of distances between enhancer and promoter may affect the expression level of genes. Our tool is based on molecular mechanics (MM) and employs the OpenMM framework[14]. The only required information is a set of contacts and optionally, directionality of CTCF motifs in the sequence. As a result, the user obtains structural data in Protein Data Bank (PDB) file format, which is convenient for further analyses in many popular software packages analyzing biomolecular structures, foe example UCSF Chimera[15]. Our tool is open-source and publicly available for both, on-line usage as a web service, and stand-alone application, that can be downloaded and tuned if so needed, for more advanced usage cases.

Web-service: www.spring-model.cent.uw.edu.pl Stand-alone version: https://bitbucket.org/4dnucleome/md_soft/

2. Method description

In SM a polymer is represented as a set of connected beads in 3D space. Their centers are distributed uniformly across the polymer chain i.e. distances between any two consecutive beads are constant and equal in bead diameter. An initial structure must be generated; self-avoiding random walk (SAWR) are a good choice for this task. The other generators of initial structure are also available for the user’s convenience (see section 6). Information about the contacts must then be provided. A contact is defined as a pair of indices, of beads i and j that are supposed to be close to each other in the resulting structure. There are many different ways to extract contacts from raw data, and this part is described more detailed in section 3.

2.1 Modeling engine and polymer energy

The identified contacts are added to a system as virtual springs (i.e. harmonic bonds), that are initially stretched. The energy of the system is then minimized, springs shorten and fiber folds into a structure that satisfies the chosen contacts. A schematic of the concept is depicted by fig. 1.

Figure 1:
  • Download figure
  • Open in new tab
Figure 1:

a) Initial structure. The initial structure depicted as a circle for clarity, is in most cases a self-avoiding random walk. Virtual springs are depicted as red sinusoidal lines. Connected beads share the same color. b) structure after energy minimisation.

Energy in spring model is defined as a sum of following terms, described in detail below: Embedded Image V is the hipersurface of potential energy. It is a function of beads’ positions in the system. Minimizing this function will lead us to find a local minimum in such surface and thus a structure that satisfies the given constraints. Embedded Image

Vbond is a potential between consecutive beads. Force constant kbond is arbitrarily chosen to be high enough so as to treat the length between beads as constant. The equilibrium constant r0 (bond length) is equal to the bead diameter σ (by default 1) and rij is at the same time the distance between beads i and j. Embedded Image

Vev is responsible for excluded volume (EV). In SM we assumed that chromatin fiber can not cross itself and each bead represents a physical amount of chromatin, possessing volume which cannot overlap with other beads. To achieve this we introduce the EV term defined as the repulsive part of Lenard-Jones potential. ϵ is a scaling factor chosen arbitrarily, and σ is the bead radius. Embedded Image

Vangle is a harmonic 3-body angle potential that gives the fiber it’s stiffness. kangle is the force constant, θijk the flat angle between consecutive beads i,j,k, and θ0 the equilibrium constant set to pi rad. These terms make the fiber straighten and are overcome by the contacts term. kangle is a parameter that strongly depends on model resolution (at lower resolutions it can be completely omitted since we can assume that unconstrained regions of regions of chromatin behave like a pure random walk. It can also be used to make loops in the model more clearly visible Embedded Image

Vcontacts is the contact’s potential. It’s very similar to Vbond, however since it has a flat dip, it allows a little more freedom for bead interactions.

Vdire, the directionality potential that allows additional loop shape optimization. This is a 4-body, dihedral angle, harmonic potential between interacting beads and their closest neighbors. It is described in more details in section 2.2.

2.2. CTCF motifs directionality and loop types

The CTCF protein recognizes appropriate motifs on DNA sequence. The directionality of these motifs is essential for forming chromatin loops, and higher level domains [16, 17]. As it was stated in [18] in the cell nucleus, there is a possibility for occurrence of two types of loops - coiled (C-loops), (fig. 2) and hairpin (H-loops). The type of loop is dependent on CTCF motifs directionality. If a motif is convergent (><) then H-loops are expected to form, whereas divergent loops do not form at all (<>). In case of motifs situated as tandem left or tandem right(<<, >>) C-loops are expected. To reflect this behavior, our methodology implements additional an force, which can be applied to bend the fiber accordingly for further loop shape optimization. Embedded Image

Figure 2:
  • Download figure
  • Open in new tab
Figure 2:

Loop types: a) Hairpin loop, b) Coiled loop. Blue rings represent binding sites. c) dihedral angles responsible for forming different loops types. Two separate terms engaging different beads are marked with a green-yellow line. Example for H-loop is depicted.

This extra term can be provided per interaction and is implemented as periodic harmonic dihedral angle force defined between consecutive beads i − 1, i, j, j + 1 and i +195 1, i, j, j − 1 with an equilibrium constant equal to 0 rad for C-loops, and π rad for H-loops, and force constant is equal to 50 kJ/mol.

3. From experimental data to set of interaction

The Spring Model was designed as a tool for building a 3D conformation that satisfy a given set of constraints. It should be used as a tool for visualization certain domain in single cell rather than population based average model as it take place in [12]. This require careful data selection and sometimes filtering. Applying to much interactions on short region of chromatin will lead to collapsing model (see fig 3). Contacts may be derived from great variety types of experiment, e.g, ChIA-PET, Hi-C, single-cell Hi-C or even ChIP-Seq processed by machine learning techniques [19]. There are several ways to extract interactions from raw data and exact method is strongly dependent on data and expected results. In following paragraphs different types of data will be characterized in the light of their usage in modelling process.

Figure 3:
  • Download figure
  • Open in new tab
Figure 3:

Radius of gyration as a function of number of interactions per 100 kbp. High Rg are indicative of a poorly folded structure, and a low Rg indicates a fully collapsed structure. Error bars indicate the standard deviation. There is no clear phase transition point. Representative structures are depicted for three clusters.

3.1. Hi-C

Hi-C are population based experiment in which one observes frequencies of all possible contacts (even accidental). It is impossible that all of them exist in the same time in single cell, thus some sampling from heat map is required. The simplest approach is just cutting off an interaction fre-quency heat map at an arbitrary level and taking what’s left – the strongest (i.e. most confident) interactions. Fur-ther studies on decomposition Hi-C heatmaps into separate cell is required.

3.2. scHi-C

Despite the development of modern experimental methods of studying the structure of the genome, several questions (important especially from a modeling point of view) remain unanswered. One of the most important is: how many contacts observed in Hi-C/ChIA-PET, or other similar experiments are actually realized in a single nucleus? The main challenge is that the aforementioned techniques give averages over millions of cells. Although there are some approaches to identify contacts in single cells [20, 21], we are still unsure how many contacts remain hidden. Single Cell Hi-C seems to be perfect technique for modelling purposes. However the main drawback of this method is that we don’t know how much contacts that really occurs we don’t see. According to our initial proof-of-the-concept tests based on data published by [20] our conclusions where that this set is not big enough to obtain well folded structures (detailed data not published).

3.3. ChIA-PET

ChIA-PET is another population based technique which shows contacts mediated by particular protein. It returns in theory a subset of contacts visible in Hi-C. It also poses much better resolution, and shows direct interactions between particular sites in chromatin. In experiments with shallow sequencing and low number of loops all interactions may be used directly. In experiments with deep sequencing, and large number of loops some sampling is required. We suggest randomly selecting the loops with probability proportional to PET-Count. This also recommended way for building ensemble of solutions if needed. Yet another approach was proposed in [22].

3.4. Impact of number of interactions

What we do know is that some contacts occur more often than others and they cannot all occur at the same time. Thus there ought to exist an average amount of chromatin per interaction, or in language of model coordinates – number of beads per interaction (BPI). What is more, the values from this parameter are closely related to the chromatin state. The active states of chromatin are associated with higher loop density [18].

To explore impact of BPI on structure, we measured the mean radius of gyration Rg, over ensembles of 1 000 generated models for our ROI (chr6:32047146-33250152), where Embedded Image, and N is number of beads, rk is a vector indicating positions of kth bead, and rmean is the geometrical (which in this case implies gravitational) center of a system. For our ROI we have selected CCDs with length in range (1-2 Mbp) that have the highest percentage of its length covered by regulatory elements. The regulatory elements were defined based on Combined ENCODE Segmentation[23]. We have included into this category following classes of regions: CTCF enriched element (CTCF), Predicted enhancer (E), Predicted promoter flanking region (PF), Predicted promoter region including TSS (TSS), Predicted weak enhancer or open chromatin cis-regulatory element (WE). For the set of experimentally resolved interactions (ChIA-PET for GM12878 cell line mapped onto hg38 genome – data not published), we were generating ensembles of models. Each model was starting from a different initial structure (SARW), and in each ensemble we chose a different number of contacts included in modeling. Contacts were randomly chosen with probability proportional to PET Count from ChIA-PET experiment. The results are depicted on fig. 3.

We did not observe any clear threshold that could be associated with phase transition from a “folded” to an “unfolded” state. However it has not escaped our notice that the specific threshold of the number of used interactions induces almost the same level of chromatin compaction. We conclude that no more than 15 interactions per 100 000 base pairs take part in forming chromatin structures in particular cells. Adding more contacts does not significantly change the level of compaction.

4. Modeling example

As an example of a use case of our modeling tool we chose TAL1 locus, a proto-oncogene activated by disruption one of CTCF sites between TAL1 and a nearby enchancer located on the CMPK1 gene [24]. The authors identified 15 ChIA-PET interactions in this region, and after ruling out one of anchors only 9 interactions remain. We are aware that the number of interactions in ChIA-PET experiments depends on sequencing depth. However, due to the small amount of loops we decided to use all of them in modeling just for visualisation purposes. We built both: a wild type model, and a model after deletion of CTCF using CRISPR. The results are depicted in the fig. 4.

Figure 4:
  • Download figure
  • Open in new tab
Figure 4:

Models of Tal1 locus for a) wild type, b) CTCF deleted with CRISPR. c) loop diagram diagram for WT, and d) ΔCTCF. Loop color saturation corresponds to PET-Count. Colors on models corresponds to colors of genes marked below arc diagrams. Deletion of CTCF binding site leads to desappear of 6 contacts which result with less compacted structure and more flexible loops.

It’s clearly visible that even if a certain anchor is deleted and some loops disappear, other can still act as an insulator between the TAL1 promoter and enhancer near CMPK1, since they still remain on distinct loops. More effort needs to be put to explore the methods of loop sampling from ChIA-PET to make this data suitable for modeling purposes.

5. Validation

Even in today’s current chromatin modeling field, there is still big deficiency of structure validating methods. It is hard even to define the criteria to be used in assessment of the reliability of a model. This deficiency is caused by lack of methods for direct study of chromatin structure (analogous to X-Ray crystallography in the case of proteins). Although there is considerable progress in the field of direct 3D imaging[25, 26], building image-driven models consistent with genomic data remains an open problem.

We access the accuracy of our modelling procedure based on the ability of proposed models to recreate the large - scale features observed for the specific cell line. To check the consistency of our approach with ChIA-PET experiment data, we generated 10 000 models starting from SARW and randomly choosing interactions with probability proportional to the PET-Count, ROI being chr7:141246953-142936866 (hg38). Then for each structure we calculate the binary contact map and sum them up. The resulting matrix bears many similarities to the original heatmap with the chessboard-like structure and enhanced signal along the loops boundaries. (fig. 5) with contact frequencies, which we assume meet the user’s expectations. We call this procedure simulated ChIA-PET. Similarly to the real experiment, only an assembly of a large enough number of models can reproduce population characteristics of the data.

Figure 5:
  • Download figure
  • Open in new tab
Figure 5:

Upper half of the heatmap shows raw ChIA-PET data that was used to model the region (chr7:141246953-142936866). Lower half depicts population-scale contact matrix obtained from summing binary contact matrices from 10 000 structures built with the Spring Model. Both matrices were normalised to convey the relative frequency of the contacts; the scale is logarithmic with base 10, dark purple being little to no contacts and yellow representing the other side of the spectrum.

In [19] we showed that there is a possibility of predicting ChIA-PET interactions from data from cheaper experiments like ChIP-Seq, and in many cases, the interaction pattern is analogous to similarities between 3D structures. We also found out that in some cases it is easy to radically change the structure by simply removing one key long range contact; whilst in other some contacts seems to be redundant because even if they are missing other neighborhood interactions keep structure folded.

6. Webservice

For user convenience our methodology was implemented as a web service available at http://spring-model.cent.uw.edu.pl. It was designed for being simple and intuitive. The landing page is a form for submitting new tasks - see Fig.6. The user has a wide variety of options that allow him or her to tailor his model according to his needs. First of all a user is able to name accordingly his task which help him easy identification later. Then the user is able to choose one of four initial structure types: (almost) straight line, circle, self-avoiding random walk and baseball. Then there are options for controlling stiffness of the fiber and size of the spherical container if it is needed. In rare cases depending on provided data and initial structure, simple molecular mechanics may have trouble with convergence to a reasonable structure, and some artifacts, or not completely folded structure may occurs. To over-pass this phenomenon, there is an option for running modeling with refinement, which means that after the first act of energy minimization there will be another 5 more cycles of running short (1000 steps) molecular dynamics (with time step Δt = 20 fs) in a temperature of 300 K and energy minimization with convergence condition equal 10 kJ/mol, and in the end yet another energy minimization run with convergence condition equal 1 kJ/mol. This usually allows to achieve lower energies of the final structure however, it costs more computational power and may extend compu-tation time from seconds to minutes depending on system.

Figure 6:
  • Download figure
  • Open in new tab
Figure 6:

Web service interface. New request form, and example of modeling results.

In the second part of the interface, user’s have an option to chose how he is going to express restraints. There are two options. One may directly provide indices of in-teracting beads, or use interactions expressed in genome coordinates saved in BEDPE file format. In first option a user can additionally provide number of beads. If this parameter will be skipped the number of beads will be equal to the highest index of bead in the list of restraints. Af-ter indices, the user may specify expected type of loop (as described in section 2.2). Using symbols of CTCF motif directionality >>, ><. <>, <<), or upper case letter (C for coiled loop, or H for hairpin loop). As another option, user have to additionally provide information about resolution i.e. amount of chromatin. Analogically fiber length can be controlled using a region of field, or it will be deduced from coordinates. Loop types can be specified as 8th column of a BEDPE file. In this case, the midpoints between starts and ends of anchors will be used for converting input data to restraints.

After few seconds to minutes, users can inspect the results on a results view presented on Fig.6. There is a multiple useful information about structure, like basic statistics – number of beads, restraints, number of beads per interaction, region length and resolution, type of initial structure, stiffness, size of spherical container, and energy of the final structure. There is also the visual representation of interactions as an arc diagram and interactive preview of structure in 3D, that allows to rotate, zoom in and zoom out the structure. If user is not satisfied with obtained model or would like to experiment with different parameters there is convenient button that redirects back to the new task form that is already populated with data from a task. For more advanced structural analysis user can download the structure in PDB file format which is widely supported by most of modern bimolecular viewer and analysis software, e.g. UCSF Chimera [15]. Additionally the user may download files with restraints saved as a pseudo bonds file format that can be rendered in UCSF Chimera. This allows for the clear examination of positions of interactions in the structure. As the final option, users may refer to provided lists of restraints or couple them with genomic interactions. Users may also visually inspect distance maps of the resultant structures.

Acknowledgment

This work has been supported by Polish National Science Centre (2014/15/B/ST6/05082), Foundation for Polish Science (TEAM to DP). The work was co-supported by grant 1U54DK107967-01 “Nucleome Positioning System for Spatiotemporal Genome Organization and Regulation? within 4DNucleome NIH program, and by European Commission as European Cooperation in Science and Technology COST actions: CA18127 “International Nucleome Consortium” (INC), and CA16212 “Impact of Nuclear Domains On Gene Expression and Plant Traits”. Authors would like to express our special thanks of gratitude to our colleagues from the laboratory who have critically examined the first version of this manuscript, and did necessary language corrections.

Footnotes

  • Email addresses: m.kadlof{at}cent.uw.edu.pl (Michal Kadlof), j.rozycka{at}cent.uw.edu.pl (Julia Rozycka)

  • https://www.spring-model.cent.uw.edu.pl

References

  1. [1].↵
    J.-M. Belton, R. P. McCord, J. H. Gibcus, N. Naumova, Y. Zhan, J. Dekker, Hi–c: a comprehensive technique to capture the conformation of genomes, Methods 58 (3) (2012) 268–276. doi:10.1016/j.ymeth.2012.05.001.
    OpenUrlCrossRefPubMedWeb of Science
  2. [2].
    J. R. Dixon, S. Selvaraj, F. Yue, A. Kim, Y. Li, Y. Shen, M. Hu, J. S. Liu, B. Ren, Topological domains in mammalian genomes identified by analysis of chromatin interactions, Nature 485 (7398) (2012) 376. doi:10.1038/nature11082.
    OpenUrlCrossRefPubMedWeb of Science
  3. [3].
    M. J. Fullwood, M. H. Liu, Y. F. Pan, J. Liu, H. Xu, Y. B. Mohamed, Y. L. Orlov, S. Velkov, A. Ho, P. H. Mei, et al., An oestrogen-receptor-α-bound human chromatin interactome, Nature 462 (7269) (2009) 58. doi:10.1038/nature08497.
    OpenUrlCrossRefPubMedWeb of Science
  4. [4].↵
    S. S. Rao, M. H. Huntley, N. C. Durand, E. K. Stamenova, D. Bochkov, J. T. Robinson, A. L. Sanborn, I. Machol, A. D. Omer, E. S. Lander, et al., A 3d map of the human genome at kilobase resolution reveals principles of chromatin looping, Cell 159 (7) (2014) 1665–1680. doi:10.1016/j.cell.2014.11.021.
    OpenUrlCrossRefPubMedWeb of Science
  5. [5].↵
    B. R. Lajoie, J. Dekker, N. Kaplan, The hitchhiker’s guide to hi-c analysis: practical guidelines, Methods 72 (2015) 65–75. doi:10.1016/j.ymeth.2014.10.031.
    OpenUrlCrossRefPubMed
  6. [6].↵
    A. Grosberg, Y. Rabin, S. Havlin, A. Neer, Crumpled globule model of the three-dimensional structure of dna, EPL (Europhysics Letters) 23 (5) (1993) 373. doi:10.1209/0295-5075/23/5/012.
    OpenUrlCrossRefWeb of Science
  7. [7].↵
    L. A. Mirny, The fractal globule as a model of chromatin architecture in the cell, Chromosome research 19 (1) (2011) 37–51. doi:10.1007/s10577-010-9177-0.
    OpenUrlCrossRefPubMedWeb of Science
  8. [8].↵
    A. Lesne, J. Riposo, P. Roger, A. Cournac, J. Mozziconacci, 3d genome reconstruction from chromosomal contacts, Nature methods 11 (11) (2014) 1141. doi:10.1038/nmeth.3104.
    OpenUrlCrossRefPubMed
  9. [9].↵
    L. Rieber, S. Mahony, minimds: 3d structural inference from high-resolution hi-c data, Bioinformatics 33 (14) (2017) i261–i266. doi:10.1093/bioinformatics/btx271.
    OpenUrlCrossRef
  10. [10].↵
    A. L. Sanborn, S. S. Rao, S.-C. Huang, N. C. Durand, M. H. Huntley, A. I. Jewett, I. D. Bochkov, D. Chinnappan, A. Cutkosky, J. Li, et al., Chromatin extrusion explains key features of loop and domain formation in wild-type and engineered genomes, Proceedings of the National Academy of Sciences 112 (47) (2015) E6456–E6465. doi:10.1073/pnas.1518552112.
    OpenUrlAbstract/FREE Full Text
  11. [11].↵
    M. Barbieri, M. Chotalia, J. Fraser, L.-M. Lavitas, J. Dostie, A. Pombo, M. Nicodemi, Complexity of chromatin folding is captured by the strings and binders switch model, Proceedings of the National Academy of Sciences 109 (40) (2012) 16173–16178. doi:10.1073/pnas.1204799109.
    OpenUrlAbstract/FREE Full Text
  12. [12].↵
    P. Szalaj, P. J. Michalski, P. Wróblewski, Z. Tang, M. Kadlof, G. Mazzocco, Y. Ruan, D. Plewczynski, 3d-gnome: an integrated web service for structural modeling of the 3d genome, Nucleic acids research 44 (W1) (2016) W288–W293. doi:10.1093/nar/gkw437.
    OpenUrlCrossRefPubMed
  13. [13].↵
    B. Zhang, P. G. Wolynes, Topology, structures, and energy landscapes of human chromosomes, Proceedings of the National Academy of Sciences 112 (19) (2015) 6062–6067. doi:10.1073/pnas.1506257112.
    OpenUrlAbstract/FREE Full Text
  14. [14].↵
    P. Eastman, M. S. Friedrichs, J. D. Chodera, R. J. Radmer, C. M. Bruns, J. P. Ku, K. A. Beauchamp, T. J. Lane, L.-P. Wang, D. Shukla, et al., Openmm 4: a reusable, extensible, hardware independent library for high performance molecular simulation, Journal of chemical theory and computation 9 (1) (2012) 461–469. doi:10.1021/ct300857j.
    OpenUrlCrossRef
  15. [15].↵
    E. F. Pettersen, T. D. Goddard, C. C. Huang, G. S. Couch, D. M. Greenblatt, E. C. Meng, T. E. Ferrin, Ucsf chimera—a visualization system for exploratory research and analysis, Journal of computational chemistry 25 (13) (2004) 1605–1612. doi:10.1002/jcc.20084.
    OpenUrlCrossRefPubMedWeb of Science
  16. [16].↵
    M. Lazniewski, W. K. Dawson, A. M. Rusek, D. Plewczynski, One protein to rule them all: The role of ccctc-binding factor in shaping human genome in health and disease, in: Seminars in cell & developmental biology, Elsevier, 2018. doi:10.1016/j.semcdb.2018.08.003.
    OpenUrlCrossRef
  17. [17].↵
    R. Ghirlando, G. Felsenfeld, Ctcf: making the right connections, Genes & development 30 (8) (2016) 881–891. doi:10.1101/gad.277863.116.
    OpenUrlAbstract/FREE Full Text
  18. [18].↵
    Z. Tang, O. J. Luo, X. Li, M. Zheng, J. J. Zhu, P. Szalaj, P. Trzaskoma, A. Magalska, J. Wlodarczyk, B. Ruszczycki, et al., Ctcf-mediated human 3d genome architecture reveals chromatin topology for transcription, Cell 163 (7) (2015) 1611–1627. doi:10.1016/j.cell.2015.11.024.
    OpenUrlCrossRefPubMed
  19. [19].↵
    Z. Al Bkhetan, M. Kadlof, A. Kraft, D. Plewczynski, Machine learning polymer models of three-dimensional chromatin organization in human lymphoblastoid cells, Methodsdoi:doi:10.1016/j.ymeth.2019.03.002.
    OpenUrlCrossRef
  20. [20].↵
    T. Nagano, Y. Lubling, T. J. Stevens, S. Schoenfelder, E. Yaffe, W. Dean, E. D. Laue, A. Tanay, P. Fraser, Single-cell hi-c re-veals cell-to-cell variability in chromosome structure, Nature 502 (7469) (2013) 59. doi:10.1038/nature12593.
    OpenUrlCrossRefPubMedWeb of Science
  21. [21].↵
    V. Ramani, X. Deng, R. Qiu, K. L. Gunderson, F. J. Steemers, C. M. Disteche, W. S. Noble, Z. Duan, J. Shendure, Massively multiplex single-cell hi-c, Nature methods 14 (3) (2017) 263. doi:10.1038/nmeth.4155.
    OpenUrlCrossRefPubMed
  22. [22].↵
    W. Dawson, D. Plewczynski, Free energy based high-resolution modeling of ctcf-mediated chromatin loops for human genome, bioRxiv (2017) 105676doi:10.1101/105676.
    OpenUrlAbstract/FREE Full Text
  23. [23].↵
    M. M. Hoffman, J. Ernst, S. P. Wilder, A. Kundaje, R. S. Harris, M. Libbrecht, B. Giardine, P. M. Ellenbogen, J. A. Bilmes, E. Birney, et al., Integrative annotation of chromatin elements from encode data, Nucleic acids research 41 (2) (2012) 827–841. doi:10.1093/nar/gks1284.
    OpenUrlCrossRefPubMedWeb of Science
  24. [24].↵
    D. Hnisz, A. S. Weintraub, D. S. Day, A.-L. Valton, R. O. Bak, C. H. Li, J. Goldmann, B. R. Lajoie, Z. P. Fan, A. A. Sigova, et al., Activation of proto-oncogenes by disruption of chromosome neighborhoods, Science 351 (6280) (2016) 1454–1458. doi:10.1126/science.aad9024.
    OpenUrlAbstract/FREE Full Text
  25. [25].↵
    H. D. Ou, S. Phan, T. J. Deerinck, A. Thor, M. H. Ellisman, C. C. O’shea, Chromemt: Visualizing 3d chromatin structure and compaction in interphase and mitotic cells, Science 357 (6349) (2017) eaag0025. doi:10.1126/science.aag0025.
    OpenUrlAbstract/FREE Full Text
  26. [26].↵
    M. Lakadamyali, M. P. Cosma, Advanced microscopy methods for visualizing chromatin structure, FEBS letters 589 (20) (2015) 3023–3030. doi:10.1016/j.febslet.2015.04.012.
    OpenUrlCrossRef
View Abstract
Back to top
PreviousNext
Posted May 20, 2019.
Download PDF
Data/Code
Email

Thank you for your interest in spreading the word about bioRxiv.

NOTE: Your email address is requested solely to identify you as the sender of this article.

Enter multiple addresses on separate lines or separate them with commas.
Spring Model – chromatin modeling tool based on OpenMM
(Your Name) has forwarded a page to you from bioRxiv
(Your Name) thought you would like to see this page from the bioRxiv website.
Share
Spring Model – chromatin modeling tool based on OpenMM
Michal Kadlof, Julia Rozycka, Dariusz Plewczynski
bioRxiv 642322; doi: https://doi.org/10.1101/642322
Digg logo Reddit logo Twitter logo CiteULike logo Facebook logo Google logo Mendeley logo
Citation Tools
Spring Model – chromatin modeling tool based on OpenMM
Michal Kadlof, Julia Rozycka, Dariusz Plewczynski
bioRxiv 642322; doi: https://doi.org/10.1101/642322

Citation Manager Formats

  • BibTeX
  • Bookends
  • EasyBib
  • EndNote (tagged)
  • EndNote 8 (xml)
  • Medlars
  • Mendeley
  • Papers
  • RefWorks Tagged
  • Ref Manager
  • RIS
  • Zotero
  • Tweet Widget
  • Facebook Like
  • Google Plus One

Subject Area

  • Genomics
Subject Areas
All Articles
  • Animal Behavior and Cognition (1545)
  • Biochemistry (2500)
  • Bioengineering (1757)
  • Bioinformatics (9729)
  • Biophysics (3929)
  • Cancer Biology (2990)
  • Cell Biology (4235)
  • Clinical Trials (135)
  • Developmental Biology (2653)
  • Ecology (4129)
  • Epidemiology (2033)
  • Evolutionary Biology (6933)
  • Genetics (5243)
  • Genomics (6532)
  • Immunology (2208)
  • Microbiology (7012)
  • Molecular Biology (2784)
  • Neuroscience (17412)
  • Paleontology (127)
  • Pathology (432)
  • Pharmacology and Toxicology (712)
  • Physiology (1068)
  • Plant Biology (2516)
  • Scientific Communication and Education (647)
  • Synthetic Biology (835)
  • Systems Biology (2699)
  • Zoology (439)