WorldWideScience

Sample records for scalable molecular dynamics

  1. On eliminating synchronous communication in molecular simulations to improve scalability

    Science.gov (United States)

    Straatsma, T. P.; Chavarría-Miranda, Daniel G.

    2013-12-01

    Molecular dynamics simulation, as a complementary tool to experimentation, has become an important methodology for the understanding and design of molecular systems as it provides access to properties that are difficult, impossible or prohibitively expensive to obtain experimentally. Many of the available software packages have been parallelized to take advantage of modern massively concurrent processing resources. The challenge in achieving parallel efficiency is commonly attributed to the fact that molecular dynamics algorithms are communication intensive. This paper illustrates how an appropriately chosen data distribution and asynchronous one-sided communication approach can be used to effectively deal with the data movement within the Global Arrays/ARMCI programming model framework. A new put_notify capability is presented here, allowing the implementation of the molecular dynamics algorithm without any explicit global or local synchronization or global data reduction operations. In addition, this push-data model is shown to very effectively allow hiding data communication behind computation. Rather than data movement or explicit global reductions, the implicit synchronization of the algorithm becomes the primary challenge for scalability. Without any explicit synchronous operations, the scalability of molecular simulations is shown to depend only on the ability to evenly balance computational load.

  2. Scalable Molecular Dynamics for Large Biomolecular Systems

    Directory of Open Access Journals (Sweden)

    Robert K. Brunner

    2000-01-01

    Full Text Available We present an optimized parallelization scheme for molecular dynamics simulations of large biomolecular systems, implemented in the production-quality molecular dynamics program NAMD. With an object-based hybrid force and spatial decomposition scheme, and an aggressive measurement-based predictive load balancing framework, we have attained speeds and speedups that are much higher than any reported in literature so far. The paper first summarizes the broad methodology we are pursuing, and the basic parallelization scheme we used. It then describes the optimizations that were instrumental in increasing performance, and presents performance results on benchmark simulations.

  3. Computational challenges of large-scale, long-time, first-principles molecular dynamics

    International Nuclear Information System (INIS)

    Kent, P R C

    2008-01-01

    Plane wave density functional calculations have traditionally been able to use the largest available supercomputing resources. We analyze the scalability of modern projector-augmented wave implementations to identify the challenges in performing molecular dynamics calculations of large systems containing many thousands of electrons. Benchmark calculations on the Cray XT4 demonstrate that global linear-algebra operations are the primary reason for limited parallel scalability. Plane-wave related operations can be made sufficiently scalable. Improving parallel linear-algebra performance is an essential step to reaching longer timescales in future large-scale molecular dynamics calculations

  4. Superlinearly scalable noise robustness of redundant coupled dynamical systems.

    Science.gov (United States)

    Kohar, Vivek; Kia, Behnam; Lindner, John F; Ditto, William L

    2016-03-01

    We illustrate through theory and numerical simulations that redundant coupled dynamical systems can be extremely robust against local noise in comparison to uncoupled dynamical systems evolving in the same noisy environment. Previous studies have shown that the noise robustness of redundant coupled dynamical systems is linearly scalable and deviations due to noise can be minimized by increasing the number of coupled units. Here, we demonstrate that the noise robustness can actually be scaled superlinearly if some conditions are met and very high noise robustness can be realized with very few coupled units. We discuss these conditions and show that this superlinear scalability depends on the nonlinearity of the individual dynamical units. The phenomenon is demonstrated in discrete as well as continuous dynamical systems. This superlinear scalability not only provides us an opportunity to exploit the nonlinearity of physical systems without being bogged down by noise but may also help us in understanding the functional role of coupled redundancy found in many biological systems. Moreover, engineers can exploit superlinear noise suppression by starting a coupled system near (not necessarily at) the appropriate initial condition.

  5. Temporal Scalability of Dynamic Volume Data using Mesh Compensated Wavelet Lifting.

    Science.gov (United States)

    Schnurrer, Wolfgang; Pallast, Niklas; Richter, Thomas; Kaup, Andre

    2017-10-12

    Due to their high resolution, dynamic medical 2D+t and 3D+t volumes from computed tomography (CT) and magnetic resonance tomography (MR) reach a size which makes them very unhandy for teleradiologic applications. A lossless scalable representation offers the advantage of a down-scaled version which can be used for orientation or previewing, while the remaining information for reconstructing the full resolution is transmitted on demand. The wavelet transform offers the desired scalability. A very high quality of the lowpass sub-band is crucial in order to use it as a down-scaled representation. We propose an approach based on compensated wavelet lifting for obtaining a scalable representation of dynamic CT and MR volumes with very high quality. The mesh compensation is feasible to model the displacement in dynamic volumes which is mainly given by expansion and contraction of tissue over time. To achieve this, we propose an optimized estimation of the mesh compensation parameters to optimally fit for dynamic volumes. Within the lifting structure, the inversion of the motion compensation is crucial in the update step. We propose to take this inversion directly into account during the estimation step and can improve the quality of the lowpass sub-band by 0.63 dB and 0.43 dB on average for our tested dynamic CT and MR volumes at the cost of an increase of the rate by 2.4% and 1.2% on average.

  6. Scalable and balanced dynamic hybrid data assimilation

    Science.gov (United States)

    Kauranne, Tuomo; Amour, Idrissa; Gunia, Martin; Kallio, Kari; Lepistö, Ahti; Koponen, Sampsa

    2017-04-01

    Scalability of complex weather forecasting suites is dependent on the technical tools available for implementing highly parallel computational kernels, but to an equally large extent also on the dependence patterns between various components of the suite, such as observation processing, data assimilation and the forecast model. Scalability is a particular challenge for 4D variational assimilation methods that necessarily couple the forecast model into the assimilation process and subject this combination to an inherently serial quasi-Newton minimization process. Ensemble based assimilation methods are naturally more parallel, but large models force ensemble sizes to be small and that results in poor assimilation accuracy, somewhat akin to shooting with a shotgun in a million-dimensional space. The Variational Ensemble Kalman Filter (VEnKF) is an ensemble method that can attain the accuracy of 4D variational data assimilation with a small ensemble size. It achieves this by processing a Gaussian approximation of the current error covariance distribution, instead of a set of ensemble members, analogously to the Extended Kalman Filter EKF. Ensemble members are re-sampled every time a new set of observations is processed from a new approximation of that Gaussian distribution which makes VEnKF a dynamic assimilation method. After this a smoothing step is applied that turns VEnKF into a dynamic Variational Ensemble Kalman Smoother VEnKS. In this smoothing step, the same process is iterated with frequent re-sampling of the ensemble but now using past iterations as surrogate observations until the end result is a smooth and balanced model trajectory. In principle, VEnKF could suffer from similar scalability issues as 4D-Var. However, this can be avoided by isolating the forecast model completely from the minimization process by implementing the latter as a wrapper code whose only link to the model is calling for many parallel and totally independent model runs, all of them

  7. Percolator: Scalable Pattern Discovery in Dynamic Graphs

    Energy Technology Data Exchange (ETDEWEB)

    Choudhury, Sutanay; Purohit, Sumit; Lin, Peng; Wu, Yinghui; Holder, Lawrence B.; Agarwal, Khushbu

    2018-02-06

    We demonstrate Percolator, a distributed system for graph pattern discovery in dynamic graphs. In contrast to conventional mining systems, Percolator advocates efficient pattern mining schemes that (1) support pattern detection with keywords; (2) integrate incremental and parallel pattern mining; and (3) support analytical queries such as trend analysis. The core idea of Percolator is to dynamically decide and verify a small fraction of patterns and their in- stances that must be inspected in response to buffered updates in dynamic graphs, with a total mining cost independent of graph size. We demonstrate a) the feasibility of incremental pattern mining by walking through each component of Percolator, b) the efficiency and scalability of Percolator over the sheer size of real-world dynamic graphs, and c) how the user-friendly GUI of Percolator inter- acts with users to support keyword-based queries that detect, browse and inspect trending patterns. We also demonstrate two user cases of Percolator, in social media trend analysis and academic collaboration analysis, respectively.

  8. Parallelization of quantum molecular dynamics simulation code

    International Nuclear Information System (INIS)

    Kato, Kaori; Kunugi, Tomoaki; Shibahara, Masahiko; Kotake, Susumu

    1998-02-01

    A quantum molecular dynamics simulation code has been developed for the analysis of the thermalization of photon energies in the molecule or materials in Kansai Research Establishment. The simulation code is parallelized for both Scalar massively parallel computer (Intel Paragon XP/S75) and Vector parallel computer (Fujitsu VPP300/12). Scalable speed-up has been obtained with a distribution to processor units by division of particle group in both parallel computers. As a result of distribution to processor units not only by particle group but also by the particles calculation that is constructed with fine calculations, highly parallelization performance is achieved in Intel Paragon XP/S75. (author)

  9. Deep Potential Molecular Dynamics: A Scalable Model with the Accuracy of Quantum Mechanics

    Science.gov (United States)

    Zhang, Linfeng; Han, Jiequn; Wang, Han; Car, Roberto; E, Weinan

    2018-04-01

    We introduce a scheme for molecular simulations, the deep potential molecular dynamics (DPMD) method, based on a many-body potential and interatomic forces generated by a carefully crafted deep neural network trained with ab initio data. The neural network model preserves all the natural symmetries in the problem. It is first-principles based in the sense that there are no ad hoc components aside from the network model. We show that the proposed scheme provides an efficient and accurate protocol in a variety of systems, including bulk materials and molecules. In all these cases, DPMD gives results that are essentially indistinguishable from the original data, at a cost that scales linearly with system size.

  10. Scalability of DL_POLY on High Performance Computing Platform

    Directory of Open Access Journals (Sweden)

    Mabule Samuel Mabakane

    2017-12-01

    Full Text Available This paper presents a case study on the scalability of several versions of the molecular dynamics code (DL_POLY performed on South Africa‘s Centre for High Performance Computing e1350 IBM Linux cluster, Sun system and Lengau supercomputers. Within this study different problem sizes were designed and the same chosen systems were employed in order to test the performance of DL_POLY using weak and strong scalability. It was found that the speed-up results for the small systems were better than large systems on both Ethernet and Infiniband network. However, simulations of large systems in DL_POLY performed well using Infiniband network on Lengau cluster as compared to e1350 and Sun supercomputer.

  11. Scalable Atomistic Simulation Algorithms for Materials Research

    Directory of Open Access Journals (Sweden)

    Aiichiro Nakano

    2002-01-01

    Full Text Available A suite of scalable atomistic simulation programs has been developed for materials research based on space-time multiresolution algorithms. Design and analysis of parallel algorithms are presented for molecular dynamics (MD simulations and quantum-mechanical (QM calculations based on the density functional theory. Performance tests have been carried out on 1,088-processor Cray T3E and 1,280-processor IBM SP3 computers. The linear-scaling algorithms have enabled 6.44-billion-atom MD and 111,000-atom QM calculations on 1,024 SP3 processors with parallel efficiency well over 90%. production-quality programs also feature wavelet-based computational-space decomposition for adaptive load balancing, spacefilling-curve-based adaptive data compression with user-defined error bound for scalable I/O, and octree-based fast visibility culling for immersive and interactive visualization of massive simulation data.

  12. Molecular engineering with artificial atoms: designing a material platform for scalable quantum spintronics and photonics

    Science.gov (United States)

    Doty, Matthew F.; Ma, Xiangyu; Zide, Joshua M. O.; Bryant, Garnett W.

    2017-09-01

    Self-assembled InAs Quantum Dots (QDs) are often called "artificial atoms" and have long been of interest as components of quantum photonic and spintronic devices. Although there has been substantial progress in demonstrating optical control of both single spins confined to a single QD and entanglement between two separated QDs, the path toward scalable quantum photonic devices based on spins remains challenging. Quantum Dot Molecules, which consist of two closely-spaced InAs QDs, have unique properties that can be engineered with the solid state analog of molecular engineering in which the composition, size, and location of both the QDs and the intervening barrier are controlled during growth. Moreover, applied electric, magnetic, and optical fields can be used to modulate, in situ, both the spin and optical properties of the molecular states. We describe how the unique photonic properties of engineered Quantum Dot Molecules can be leveraged to overcome long-standing challenges to the creation of scalable quantum devices that manipulate single spins via photonics.

  13. AWE-WQ: fast-forwarding molecular dynamics using the accelerated weighted ensemble.

    Science.gov (United States)

    Abdul-Wahid, Badi'; Feng, Haoyun; Rajan, Dinesh; Costaouec, Ronan; Darve, Eric; Thain, Douglas; Izaguirre, Jesús A

    2014-10-27

    A limitation of traditional molecular dynamics (MD) is that reaction rates are difficult to compute. This is due to the rarity of observing transitions between metastable states since high energy barriers trap the system in these states. Recently the weighted ensemble (WE) family of methods have emerged which can flexibly and efficiently sample conformational space without being trapped and allow calculation of unbiased rates. However, while WE can sample correctly and efficiently, a scalable implementation applicable to interesting biomolecular systems is not available. We provide here a GPLv2 implementation called AWE-WQ of a WE algorithm using the master/worker distributed computing WorkQueue (WQ) framework. AWE-WQ is scalable to thousands of nodes and supports dynamic allocation of computer resources, heterogeneous resource usage (such as central processing units (CPU) and graphical processing units (GPUs) concurrently), seamless heterogeneous cluster usage (i.e., campus grids and cloud providers), and support for arbitrary MD codes such as GROMACS, while ensuring that all statistics are unbiased. We applied AWE-WQ to a 34 residue protein which simulated 1.5 ms over 8 months with peak aggregate performance of 1000 ns/h. Comparison was done with a 200 μs simulation collected on a GPU over a similar timespan. The folding and unfolded rates were of comparable accuracy.

  14. High-performance modeling of CO2 sequestration by coupling reservoir simulation and molecular dynamics

    KAUST Repository

    Bao, Kai

    2013-01-01

    The present work describes a parallel computational framework for CO2 sequestration simulation by coupling reservoir simulation and molecular dynamics (MD) on massively parallel HPC systems. In this framework, a parallel reservoir simulator, Reservoir Simulation Toolbox (RST), solves the flow and transport equations that describe the subsurface flow behavior, while the molecular dynamics simulations are performed to provide the required physical parameters. Numerous technologies from different fields are employed to make this novel coupled system work efficiently. One of the major applications of the framework is the modeling of large scale CO2 sequestration for long-term storage in the subsurface geological formations, such as depleted reservoirs and deep saline aquifers, which has been proposed as one of the most attractive and practical solutions to reduce the CO2 emission problem to address the global-warming threat. To effectively solve such problems, fine grids and accurate prediction of the properties of fluid mixtures are essential for accuracy. In this work, the CO2 sequestration is presented as our first example to couple the reservoir simulation and molecular dynamics, while the framework can be extended naturally to the full multiphase multicomponent compositional flow simulation to handle more complicated physical process in the future. Accuracy and scalability analysis are performed on an IBM BlueGene/P and on an IBM BlueGene/Q, the latest IBM supercomputer. Results show good accuracy of our MD simulations compared with published data, and good scalability are observed with the massively parallel HPC systems. The performance and capacity of the proposed framework are well demonstrated with several experiments with hundreds of millions to a billion cells. To our best knowledge, the work represents the first attempt to couple the reservoir simulation and molecular simulation for large scale modeling. Due to the complexity of the subsurface systems

  15. A concurrent multiscale micromorphic molecular dynamics

    International Nuclear Information System (INIS)

    Li, Shaofan; Tong, Qi

    2015-01-01

    In this work, we have derived a multiscale micromorphic molecular dynamics (MMMD) from first principle to extend the (Andersen)-Parrinello-Rahman molecular dynamics to mesoscale and continuum scale. The multiscale micromorphic molecular dynamics is a con-current three-scale dynamics that couples a fine scale molecular dynamics, a mesoscale micromorphic dynamics, and a macroscale nonlocal particle dynamics together. By choosing proper statistical closure conditions, we have shown that the original Andersen-Parrinello-Rahman molecular dynamics is the homogeneous and equilibrium case of the proposed multiscale micromorphic molecular dynamics. In specific, we have shown that the Andersen-Parrinello-Rahman molecular dynamics can be rigorously formulated and justified from first principle, and its general inhomogeneous case, i.e., the three scale con-current multiscale micromorphic molecular dynamics can take into account of macroscale continuum mechanics boundary condition without the limitation of atomistic boundary condition or periodic boundary conditions. The discovered multiscale scale structure and the corresponding multiscale dynamics reveal a seamless transition from atomistic scale to continuum scale and the intrinsic coupling mechanism among them based on first principle formulation

  16. Scalability of a Low-Cost Multi-Teraflop Linux Cluster for High-End Classical Atomistic and Quantum Mechanical Simulations

    Science.gov (United States)

    Kikuchi, Hideaki; Kalia, Rajiv K.; Nakano, Aiichiro; Vashishta, Priya; Shimojo, Fuyuki; Saini, Subhash

    2003-01-01

    Scalability of a low-cost, Intel Xeon-based, multi-Teraflop Linux cluster is tested for two high-end scientific applications: Classical atomistic simulation based on the molecular dynamics method and quantum mechanical calculation based on the density functional theory. These scalable parallel applications use space-time multiresolution algorithms and feature computational-space decomposition, wavelet-based adaptive load balancing, and spacefilling-curve-based data compression for scalable I/O. Comparative performance tests are performed on a 1,024-processor Linux cluster and a conventional higher-end parallel supercomputer, 1,184-processor IBM SP4. The results show that the performance of the Linux cluster is comparable to that of the SP4. We also study various effects, such as the sharing of memory and L2 cache among processors, on the performance.

  17. MDGRAPE-4: a special-purpose computer system for molecular dynamics simulations.

    Science.gov (United States)

    Ohmura, Itta; Morimoto, Gentaro; Ohno, Yousuke; Hasegawa, Aki; Taiji, Makoto

    2014-08-06

    We are developing the MDGRAPE-4, a special-purpose computer system for molecular dynamics (MD) simulations. MDGRAPE-4 is designed to achieve strong scalability for protein MD simulations through the integration of general-purpose cores, dedicated pipelines, memory banks and network interfaces (NIFs) to create a system on chip (SoC). Each SoC has 64 dedicated pipelines that are used for non-bonded force calculations and run at 0.8 GHz. Additionally, it has 65 Tensilica Xtensa LX cores with single-precision floating-point units that are used for other calculations and run at 0.6 GHz. At peak performance levels, each SoC can evaluate 51.2 G interactions per second. It also has 1.8 MB of embedded shared memory banks and six network units with a peak bandwidth of 7.2 GB s(-1) for the three-dimensional torus network. The system consists of 512 (8×8×8) SoCs in total, which are mounted on 64 node modules with eight SoCs. The optical transmitters/receivers are used for internode communication. The expected maximum power consumption is 50 kW. While MDGRAPE-4 software has still been improved, we plan to run MD simulations on MDGRAPE-4 in 2014. The MDGRAPE-4 system will enable long-time molecular dynamics simulations of small systems. It is also useful for multiscale molecular simulations where the particle simulation parts often become bottlenecks.

  18. Scalable improvement of SPME multipolar electrostatics in anisotropic polarizable molecular mechanics using a general short-range penetration correction up to quadrupoles.

    Science.gov (United States)

    Narth, Christophe; Lagardère, Louis; Polack, Étienne; Gresh, Nohad; Wang, Qiantao; Bell, David R; Rackers, Joshua A; Ponder, Jay W; Ren, Pengyu Y; Piquemal, Jean-Philip

    2016-02-15

    We propose a general coupling of the Smooth Particle Mesh Ewald SPME approach for distributed multipoles to a short-range charge penetration correction modifying the charge-charge, charge-dipole and charge-quadrupole energies. Such an approach significantly improves electrostatics when compared to ab initio values and has been calibrated on Symmetry-Adapted Perturbation Theory reference data. Various neutral molecular dimers have been tested and results on the complexes of mono- and divalent cations with a water ligand are also provided. Transferability of the correction is adressed in the context of the implementation of the AMOEBA and SIBFA polarizable force fields in the TINKER-HP software. As the choices of the multipolar distribution are discussed, conclusions are drawn for the future penetration-corrected polarizable force fields highlighting the mandatory need of non-spurious procedures for the obtention of well balanced and physically meaningful distributed moments. Finally, scalability and parallelism of the short-range corrected SPME approach are addressed, demonstrating that the damping function is computationally affordable and accurate for molecular dynamics simulations of complex bio- or bioinorganic systems in periodic boundary conditions. Copyright © 2016 Wiley Periodicals, Inc.

  19. Conformation analysis of trehalose. Molecular dynamics simulation and molecular mechanics

    International Nuclear Information System (INIS)

    Donnamaira, M.C.; Howard, E.I.; Grigera, J.R.

    1992-09-01

    Conformational analysis of the disaccharide trehalose is done by molecular dynamics and molecular mechanics. In spite of the different force fields used in each case, comparison between the molecular dynamics trajectories of the torsional angles of glycosidic linkage and energy conformational map shows a good agreement between both methods. By molecular dynamics it is observed a moderate mobility of the glycosidic linkage. The demands of computer time is comparable in both cases. (author). 6 refs, 4 figs

  20. Computational Fluid Dynamics (CFD) Computations With Zonal Navier-Stokes Flow Solver (ZNSFLOW) Common High Performance Computing Scalable Software Initiative (CHSSI) Software

    National Research Council Canada - National Science Library

    Edge, Harris

    1999-01-01

    ...), computational fluid dynamics (CFD) 6 project. Under the project, a proven zonal Navier-Stokes solver was rewritten for scalable parallel performance on both shared memory and distributed memory high performance computers...

  1. WIFIRE: A Scalable Data-Driven Monitoring, Dynamic Prediction and Resilience Cyberinfrastructure for Wildfires

    Science.gov (United States)

    Altintas, I.; Block, J.; Braun, H.; de Callafon, R. A.; Gollner, M. J.; Smarr, L.; Trouve, A.

    2013-12-01

    Recent studies confirm that climate change will cause wildfires to increase in frequency and severity in the coming decades especially for California and in much of the North American West. The most critical sustainability issue in the midst of these ever-changing dynamics is how to achieve a new social-ecological equilibrium of this fire ecology. Wildfire wind speeds and directions change in an instant, and first responders can only be effective when they take action as quickly as the conditions change. To deliver information needed for sustainable policy and management in this dynamically changing fire regime, we must capture these details to understand the environmental processes. We are building an end-to-end cyberinfrastructure (CI), called WIFIRE, for real-time and data-driven simulation, prediction and visualization of wildfire behavior. The WIFIRE integrated CI system supports social-ecological resilience to the changing fire ecology regime in the face of urban dynamics and climate change. Networked observations, e.g., heterogeneous satellite data and real-time remote sensor data is integrated with computational techniques in signal processing, visualization, modeling and data assimilation to provide a scalable, technological, and educational solution to monitor weather patterns to predict a wildfire's Rate of Spread. Our collaborative WIFIRE team of scientists, engineers, technologists, government policy managers, private industry, and firefighters architects implement CI pathways that enable joint innovation for wildfire management. Scientific workflows are used as an integrative distributed programming model and simplify the implementation of engineering modules for data-driven simulation, prediction and visualization while allowing integration with large-scale computing facilities. WIFIRE will be scalable to users with different skill-levels via specialized web interfaces and user-specified alerts for environmental events broadcasted to receivers before

  2. A derivation and scalable implementation of the synchronous parallel kinetic Monte Carlo method for simulating long-time dynamics

    Science.gov (United States)

    Byun, Hye Suk; El-Naggar, Mohamed Y.; Kalia, Rajiv K.; Nakano, Aiichiro; Vashishta, Priya

    2017-10-01

    Kinetic Monte Carlo (KMC) simulations are used to study long-time dynamics of a wide variety of systems. Unfortunately, the conventional KMC algorithm is not scalable to larger systems, since its time scale is inversely proportional to the simulated system size. A promising approach to resolving this issue is the synchronous parallel KMC (SPKMC) algorithm, which makes the time scale size-independent. This paper introduces a formal derivation of the SPKMC algorithm based on local transition-state and time-dependent Hartree approximations, as well as its scalable parallel implementation based on a dual linked-list cell method. The resulting algorithm has achieved a weak-scaling parallel efficiency of 0.935 on 1024 Intel Xeon processors for simulating biological electron transfer dynamics in a 4.2 billion-heme system, as well as decent strong-scaling parallel efficiency. The parallel code has been used to simulate a lattice of cytochrome complexes on a bacterial-membrane nanowire, and it is broadly applicable to other problems such as computational synthesis of new materials.

  3. A divide-conquer-recombine algorithmic paradigm for large spatiotemporal quantum molecular dynamics simulations

    Science.gov (United States)

    Shimojo, Fuyuki; Hattori, Shinnosuke; Kalia, Rajiv K.; Kunaseth, Manaschai; Mou, Weiwei; Nakano, Aiichiro; Nomura, Ken-ichi; Ohmura, Satoshi; Rajak, Pankaj; Shimamura, Kohei; Vashishta, Priya

    2014-05-01

    We introduce an extension of the divide-and-conquer (DC) algorithmic paradigm called divide-conquer-recombine (DCR) to perform large quantum molecular dynamics (QMD) simulations on massively parallel supercomputers, in which interatomic forces are computed quantum mechanically in the framework of density functional theory (DFT). In DCR, the DC phase constructs globally informed, overlapping local-domain solutions, which in the recombine phase are synthesized into a global solution encompassing large spatiotemporal scales. For the DC phase, we design a lean divide-and-conquer (LDC) DFT algorithm, which significantly reduces the prefactor of the O(N) computational cost for N electrons by applying a density-adaptive boundary condition at the peripheries of the DC domains. Our globally scalable and locally efficient solver is based on a hybrid real-reciprocal space approach that combines: (1) a highly scalable real-space multigrid to represent the global charge density; and (2) a numerically efficient plane-wave basis for local electronic wave functions and charge density within each domain. Hybrid space-band decomposition is used to implement the LDC-DFT algorithm on parallel computers. A benchmark test on an IBM Blue Gene/Q computer exhibits an isogranular parallel efficiency of 0.984 on 786 432 cores for a 50.3 × 106-atom SiC system. As a test of production runs, LDC-DFT-based QMD simulation involving 16 661 atoms is performed on the Blue Gene/Q to study on-demand production of hydrogen gas from water using LiAl alloy particles. As an example of the recombine phase, LDC-DFT electronic structures are used as a basis set to describe global photoexcitation dynamics with nonadiabatic QMD (NAQMD) and kinetic Monte Carlo (KMC) methods. The NAQMD simulations are based on the linear response time-dependent density functional theory to describe electronic excited states and a surface-hopping approach to describe transitions between the excited states. A series of techniques

  4. A divide-conquer-recombine algorithmic paradigm for large spatiotemporal quantum molecular dynamics simulations

    International Nuclear Information System (INIS)

    Shimojo, Fuyuki; Hattori, Shinnosuke; Kalia, Rajiv K.; Mou, Weiwei; Nakano, Aiichiro; Nomura, Ken-ichi; Rajak, Pankaj; Vashishta, Priya; Kunaseth, Manaschai; Ohmura, Satoshi; Shimamura, Kohei

    2014-01-01

    We introduce an extension of the divide-and-conquer (DC) algorithmic paradigm called divide-conquer-recombine (DCR) to perform large quantum molecular dynamics (QMD) simulations on massively parallel supercomputers, in which interatomic forces are computed quantum mechanically in the framework of density functional theory (DFT). In DCR, the DC phase constructs globally informed, overlapping local-domain solutions, which in the recombine phase are synthesized into a global solution encompassing large spatiotemporal scales. For the DC phase, we design a lean divide-and-conquer (LDC) DFT algorithm, which significantly reduces the prefactor of the O(N) computational cost for N electrons by applying a density-adaptive boundary condition at the peripheries of the DC domains. Our globally scalable and locally efficient solver is based on a hybrid real-reciprocal space approach that combines: (1) a highly scalable real-space multigrid to represent the global charge density; and (2) a numerically efficient plane-wave basis for local electronic wave functions and charge density within each domain. Hybrid space-band decomposition is used to implement the LDC-DFT algorithm on parallel computers. A benchmark test on an IBM Blue Gene/Q computer exhibits an isogranular parallel efficiency of 0.984 on 786 432 cores for a 50.3 × 10 6 -atom SiC system. As a test of production runs, LDC-DFT-based QMD simulation involving 16 661 atoms is performed on the Blue Gene/Q to study on-demand production of hydrogen gas from water using LiAl alloy particles. As an example of the recombine phase, LDC-DFT electronic structures are used as a basis set to describe global photoexcitation dynamics with nonadiabatic QMD (NAQMD) and kinetic Monte Carlo (KMC) methods. The NAQMD simulations are based on the linear response time-dependent density functional theory to describe electronic excited states and a surface-hopping approach to describe transitions between the excited states. A series of

  5. A domain specific language for performance portable molecular dynamics algorithms

    Science.gov (United States)

    Saunders, William Robert; Grant, James; Müller, Eike Hermann

    2018-03-01

    Developers of Molecular Dynamics (MD) codes face significant challenges when adapting existing simulation packages to new hardware. In a continuously diversifying hardware landscape it becomes increasingly difficult for scientists to be experts both in their own domain (physics/chemistry/biology) and specialists in the low level parallelisation and optimisation of their codes. To address this challenge, we describe a "Separation of Concerns" approach for the development of parallel and optimised MD codes: the science specialist writes code at a high abstraction level in a domain specific language (DSL), which is then translated into efficient computer code by a scientific programmer. In a related context, an abstraction for the solution of partial differential equations with grid based methods has recently been implemented in the (Py)OP2 library. Inspired by this approach, we develop a Python code generation system for molecular dynamics simulations on different parallel architectures, including massively parallel distributed memory systems and GPUs. We demonstrate the efficiency of the auto-generated code by studying its performance and scalability on different hardware and compare it to other state-of-the-art simulation packages. With growing data volumes the extraction of physically meaningful information from the simulation becomes increasingly challenging and requires equally efficient implementations. A particular advantage of our approach is the easy expression of such analysis algorithms. We consider two popular methods for deducing the crystalline structure of a material from the local environment of each atom, show how they can be expressed in our abstraction and implement them in the code generation framework.

  6. High-Performance First-Principles Molecular Dynamics for Predictive Theory and Modeling

    Energy Technology Data Exchange (ETDEWEB)

    Gygi, Francois [Univ. of California, Davis, CA (United States). Dept. of Computer Science; Galli, Giulia [Univ. of Chicago, IL (United States); Schwegler, Eric [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2017-12-03

    This project focused on developing high-performance software tools for First-Principles Molecular Dynamics (FPMD) simulations, and applying them in investigations of materials relevant to energy conversion processes. FPMD is an atomistic simulation method that combines a quantum-mechanical description of electronic structure with the statistical description provided by molecular dynamics (MD) simulations. This reliance on fundamental principles allows FPMD simulations to provide a consistent description of structural, dynamical and electronic properties of a material. This is particularly useful in systems for which reliable empirical models are lacking. FPMD simulations are increasingly used as a predictive tool for applications such as batteries, solar energy conversion, light-emitting devices, electro-chemical energy conversion devices and other materials. During the course of the project, several new features were developed and added to the open-source Qbox FPMD code. The code was further optimized for scalable operation of large-scale, Leadership-Class DOE computers. When combined with Many-Body Perturbation Theory (MBPT) calculations, this infrastructure was used to investigate structural and electronic properties of liquid water, ice, aqueous solutions, nanoparticles and solid-liquid interfaces. Computing both ionic trajectories and electronic structure in a consistent manner enabled the simulation of several spectroscopic properties, such as Raman spectra, infrared spectra, and sum-frequency generation spectra. The accuracy of the approximations used allowed for direct comparisons of results with experimental data such as optical spectra, X-ray and neutron diffraction spectra. The software infrastructure developed in this project, as applied to various investigations of solids, liquids and interfaces, demonstrates that FPMD simulations can provide a detailed, atomic-scale picture of structural, vibrational and electronic properties of complex systems

  7. Evaluation of 3D printed anatomically scalable transfemoral prosthetic knee.

    Science.gov (United States)

    Ramakrishnan, Tyagi; Schlafly, Millicent; Reed, Kyle B

    2017-07-01

    This case study compares a transfemoral amputee's gait while using the existing Ossur Total Knee 2000 and our novel 3D printed anatomically scalable transfemoral prosthetic knee. The anatomically scalable transfemoral prosthetic knee is 3D printed out of a carbon-fiber and nylon composite that has a gear-mesh coupling with a hard-stop weight-actuated locking mechanism aided by a cross-linked four-bar spring mechanism. This design can be scaled using anatomical dimensions of a human femur and tibia to have a unique fit for each user. The transfemoral amputee who was tested is high functioning and walked on the Computer Assisted Rehabilitation Environment (CAREN) at a self-selected pace. The motion capture and force data that was collected showed that there were distinct differences in the gait dynamics. The data was used to perform the Combined Gait Asymmetry Metric (CGAM), where the scores revealed that the overall asymmetry of the gait on the Ossur Total Knee was more asymmetric than the anatomically scalable transfemoral prosthetic knee. The anatomically scalable transfemoral prosthetic knee had higher peak knee flexion that caused a large step time asymmetry. This made walking on the anatomically scalable transfemoral prosthetic knee more strenuous due to the compensatory movements in adapting to the different dynamics. This can be overcome by tuning the cross-linked spring mechanism to emulate the dynamics of the subject better. The subject stated that the knee would be good for daily use and has the potential to be adapted as a running knee.

  8. LOGISTIC NETWORK REGRESSION FOR SCALABLE ANALYSIS OF NETWORKS WITH JOINT EDGE/VERTEX DYNAMICS.

    Science.gov (United States)

    Almquist, Zack W; Butts, Carter T

    2014-08-01

    Change in group size and composition has long been an important area of research in the social sciences. Similarly, interest in interaction dynamics has a long history in sociology and social psychology. However, the effects of endogenous group change on interaction dynamics are a surprisingly understudied area. One way to explore these relationships is through social network models. Network dynamics may be viewed as a process of change in the edge structure of a network, in the vertex set on which edges are defined, or in both simultaneously. Although early studies of such processes were primarily descriptive, recent work on this topic has increasingly turned to formal statistical models. Although showing great promise, many of these modern dynamic models are computationally intensive and scale very poorly in the size of the network under study and/or the number of time points considered. Likewise, currently used models focus on edge dynamics, with little support for endogenously changing vertex sets. Here, the authors show how an existing approach based on logistic network regression can be extended to serve as a highly scalable framework for modeling large networks with dynamic vertex sets. The authors place this approach within a general dynamic exponential family (exponential-family random graph modeling) context, clarifying the assumptions underlying the framework (and providing a clear path for extensions), and they show how model assessment methods for cross-sectional networks can be extended to the dynamic case. Finally, the authors illustrate this approach on a classic data set involving interactions among windsurfers on a California beach.

  9. Color molecular dynamics for dense matter

    International Nuclear Information System (INIS)

    Maruyama, Toshiki; Hatsuda, Tetsuo

    2000-01-01

    We propose a microscopic approach for quark many-body system based on molecular dynamics. Using color confinement and one-gluon exchange potentials together with meson exchange potentials between quarks, we construct nucleons and nuclear/quark matter. Dynamical transition between confinement and deconfinement phases are studied at high baryon density with this molecular dynamics simulation. (author)

  10. A scalable double-barcode sequencing platform for characterization of dynamic protein-protein interactions.

    Science.gov (United States)

    Schlecht, Ulrich; Liu, Zhimin; Blundell, Jamie R; St Onge, Robert P; Levy, Sasha F

    2017-05-25

    Several large-scale efforts have systematically catalogued protein-protein interactions (PPIs) of a cell in a single environment. However, little is known about how the protein interactome changes across environmental perturbations. Current technologies, which assay one PPI at a time, are too low throughput to make it practical to study protein interactome dynamics. Here, we develop a highly parallel protein-protein interaction sequencing (PPiSeq) platform that uses a novel double barcoding system in conjunction with the dihydrofolate reductase protein-fragment complementation assay in Saccharomyces cerevisiae. PPiSeq detects PPIs at a rate that is on par with current assays and, in contrast with current methods, quantitatively scores PPIs with enough accuracy and sensitivity to detect changes across environments. Both PPI scoring and the bulk of strain construction can be performed with cell pools, making the assay scalable and easily reproduced across environments. PPiSeq is therefore a powerful new tool for large-scale investigations of dynamic PPIs.

  11. Lattice dynamics and molecular dynamics simulation of complex materials

    International Nuclear Information System (INIS)

    Chaplot, S.L.

    1997-01-01

    In this article we briefly review the lattice dynamics and molecular dynamics simulation techniques, as used for complex ionic and molecular solids, and demonstrate a number of applications through examples of our work. These computational studies, along with experiments, have provided microscopic insight into the structure and dynamics, phase transitions and thermodynamical properties of a variety of materials including fullerene, high temperature superconducting oxides and geological minerals as a function of pressure and temperature. The computational techniques also allow the study of the structures and dynamics associated with disorder, defects, surfaces, interfaces etc. (author)

  12. Molecular dynamics for irradiation driven chemistry

    DEFF Research Database (Denmark)

    Sushko, Gennady B.; Solov'yov, Ilia A.; Solov'yov, Andrey V.

    2016-01-01

    A new molecular dynamics (MD) approach for computer simulations of irradiation driven chemical transformations of complex molecular systems is suggested. The approach is based on the fact that irradiation induced quantum transformations can often be treated as random, fast and local processes...... that describe the classical MD of complex molecular systems under irradiation. The proposed irradiation driven molecular dynamics (IDMD) methodology is designed for the molecular level description of the irradiation driven chemistry. The IDMD approach is implemented into the MBN Explorer software package...... involving small molecules or molecular fragments. We advocate that the quantum transformations, such as molecular bond breaks, creation and annihilation of dangling bonds, electronic charge redistributions, changes in molecular topologies, etc., could be incorporated locally into the molecular force fields...

  13. Substructured multibody molecular dynamics.

    Energy Technology Data Exchange (ETDEWEB)

    Grest, Gary Stephen; Stevens, Mark Jackson; Plimpton, Steven James; Woolf, Thomas B. (Johns Hopkins University, Baltimore, MD); Lehoucq, Richard B.; Crozier, Paul Stewart; Ismail, Ahmed E.; Mukherjee, Rudranarayan M. (Rensselaer Polytechnic Institute, Troy, NY); Draganescu, Andrei I.

    2006-11-01

    We have enhanced our parallel molecular dynamics (MD) simulation software LAMMPS (Large-scale Atomic/Molecular Massively Parallel Simulator, lammps.sandia.gov) to include many new features for accelerated simulation including articulated rigid body dynamics via coupling to the Rensselaer Polytechnic Institute code POEMS (Parallelizable Open-source Efficient Multibody Software). We use new features of the LAMMPS software package to investigate rhodopsin photoisomerization, and water model surface tension and capillary waves at the vapor-liquid interface. Finally, we motivate the recipes of MD for practitioners and researchers in numerical analysis and computational mechanics.

  14. A Kepler Workflow Tool for Reproducible AMBER GPU Molecular Dynamics.

    Science.gov (United States)

    Purawat, Shweta; Ieong, Pek U; Malmstrom, Robert D; Chan, Garrett J; Yeung, Alan K; Walker, Ross C; Altintas, Ilkay; Amaro, Rommie E

    2017-06-20

    With the drive toward high throughput molecular dynamics (MD) simulations involving ever-greater numbers of simulation replicates run for longer, biologically relevant timescales (microseconds), the need for improved computational methods that facilitate fully automated MD workflows gains more importance. Here we report the development of an automated workflow tool to perform AMBER GPU MD simulations. Our workflow tool capitalizes on the capabilities of the Kepler platform to deliver a flexible, intuitive, and user-friendly environment and the AMBER GPU code for a robust and high-performance simulation engine. Additionally, the workflow tool reduces user input time by automating repetitive processes and facilitates access to GPU clusters, whose high-performance processing power makes simulations of large numerical scale possible. The presented workflow tool facilitates the management and deployment of large sets of MD simulations on heterogeneous computing resources. The workflow tool also performs systematic analysis on the simulation outputs and enhances simulation reproducibility, execution scalability, and MD method development including benchmarking and validation. Copyright © 2017 Biophysical Society. Published by Elsevier Inc. All rights reserved.

  15. An Evaluation of Explicit Receptor Flexibility in Molecular Docking Using Molecular Dynamics and Torsion Angle Molecular Dynamics.

    Science.gov (United States)

    Armen, Roger S; Chen, Jianhan; Brooks, Charles L

    2009-10-13

    Incorporating receptor flexibility into molecular docking should improve results for flexible proteins. However, the incorporation of explicit all-atom flexibility with molecular dynamics for the entire protein chain may also introduce significant error and "noise" that could decrease docking accuracy and deteriorate the ability of a scoring function to rank native-like poses. We address this apparent paradox by comparing the success of several flexible receptor models in cross-docking and multiple receptor ensemble docking for p38α mitogen-activated protein (MAP) kinase. Explicit all-atom receptor flexibility has been incorporated into a CHARMM-based molecular docking method (CDOCKER) using both molecular dynamics (MD) and torsion angle molecular dynamics (TAMD) for the refinement of predicted protein-ligand binding geometries. These flexible receptor models have been evaluated, and the accuracy and efficiency of TAMD sampling is directly compared to MD sampling. Several flexible receptor models are compared, encompassing flexible side chains, flexible loops, multiple flexible backbone segments, and treatment of the entire chain as flexible. We find that although including side chain and some backbone flexibility is required for improved docking accuracy as expected, docking accuracy also diminishes as additional and unnecessary receptor flexibility is included into the conformational search space. Ensemble docking results demonstrate that including protein flexibility leads to to improved agreement with binding data for 227 active compounds. This comparison also demonstrates that a flexible receptor model enriches high affinity compound identification without significantly increasing the number of false positives from low affinity compounds.

  16. Approximation of quantum observables by molecular dynamics simulations

    KAUST Repository

    Sandberg, Mattias

    2016-01-01

    In this talk I will discuss how to estimate the uncertainty in molecular dynamics simulations. Molecular dynamics is a computational method to study molecular systems in materials science, chemistry, and molecular biology. The wide popularity of molecular dynamics simulations relies on the fact that in many cases it agrees very well with experiments. If we however want the simulation to predict something that has no comparing experiment, we need a mathematical estimate of the accuracy of the computation. In the case of molecular systems with few particles, such studies are made by directly solving the Schrodinger equation. In this talk I will discuss theoretical results on the accuracy between quantum mechanics and molecular dynamics, to be used for systems that are too large to be handled computationally by the Schrodinger equation.

  17. Approximation of quantum observables by molecular dynamics simulations

    KAUST Repository

    Sandberg, Mattias

    2016-01-06

    In this talk I will discuss how to estimate the uncertainty in molecular dynamics simulations. Molecular dynamics is a computational method to study molecular systems in materials science, chemistry, and molecular biology. The wide popularity of molecular dynamics simulations relies on the fact that in many cases it agrees very well with experiments. If we however want the simulation to predict something that has no comparing experiment, we need a mathematical estimate of the accuracy of the computation. In the case of molecular systems with few particles, such studies are made by directly solving the Schrodinger equation. In this talk I will discuss theoretical results on the accuracy between quantum mechanics and molecular dynamics, to be used for systems that are too large to be handled computationally by the Schrodinger equation.

  18. Polymer friction Molecular Dynamics

    DEFF Research Database (Denmark)

    Sivebæk, Ion Marius; Samoilov, Vladimir N.; Persson, Bo N. J.

    We present molecular dynamics friction calculations for confined hydrocarbon solids with molecular lengths from 20 to 1400 carbon atoms. Two cases are considered: a) polymer sliding against a hard substrate, and b) polymer sliding on polymer. In the first setup the shear stresses are relatively...... independent of molecular length. For polymer sliding on polymer the friction is significantly larger, and dependent on the molecular chain length. In both cases, the shear stresses are proportional to the squeezing pressure and finite at zero load, indicating an adhesional contribution to the friction force....

  19. Next generation extended Lagrangian first principles molecular dynamics.

    Science.gov (United States)

    Niklasson, Anders M N

    2017-08-07

    Extended Lagrangian Born-Oppenheimer molecular dynamics [A. M. N. Niklasson, Phys. Rev. Lett. 100, 123004 (2008)] is formulated for general Hohenberg-Kohn density-functional theory and compared with the extended Lagrangian framework of first principles molecular dynamics by Car and Parrinello [Phys. Rev. Lett. 55, 2471 (1985)]. It is shown how extended Lagrangian Born-Oppenheimer molecular dynamics overcomes several shortcomings of regular, direct Born-Oppenheimer molecular dynamics, while improving or maintaining important features of Car-Parrinello simulations. The accuracy of the electronic degrees of freedom in extended Lagrangian Born-Oppenheimer molecular dynamics, with respect to the exact Born-Oppenheimer solution, is of second-order in the size of the integration time step and of fourth order in the potential energy surface. Improved stability over recent formulations of extended Lagrangian Born-Oppenheimer molecular dynamics is achieved by generalizing the theory to finite temperature ensembles, using fractional occupation numbers in the calculation of the inner-product kernel of the extended harmonic oscillator that appears as a preconditioner in the electronic equations of motion. Material systems that normally exhibit slow self-consistent field convergence can be simulated using integration time steps of the same order as in direct Born-Oppenheimer molecular dynamics, but without the requirement of an iterative, non-linear electronic ground-state optimization prior to the force evaluations and without a systematic drift in the total energy. In combination with proposed low-rank and on the fly updates of the kernel, this formulation provides an efficient and general framework for quantum-based Born-Oppenheimer molecular dynamics simulations.

  20. Analysis of Time Reversible Born-Oppenheimer Molecular Dynamics

    Directory of Open Access Journals (Sweden)

    Lin Lin

    2013-12-01

    Full Text Available We analyze the time reversible Born-Oppenheimer molecular dynamics (TRBOMD scheme, which preserves the time reversibility of the Born-Oppenheimer molecular dynamics even with non-convergent self-consistent field iteration. In the linear response regime, we derive the stability condition, as well as the accuracy of TRBOMD for computing physical properties, such as the phonon frequency obtained from the molecular dynamics simulation. We connect and compare TRBOMD with Car-Parrinello molecular dynamics in terms of accuracy and stability. We further discuss the accuracy of TRBOMD beyond the linear response regime for non-equilibrium dynamics of nuclei. Our results are demonstrated through numerical experiments using a simplified one-dimensional model for Kohn-Sham density functional theory.

  1. A Molecular Dynamics Study of Lunasin | Singh | South African ...

    African Journals Online (AJOL)

    A Molecular Dynamics Study of Lunasin. ... profile of lunasin,using classical molecular dynamics (MD) simulations at the time scale of 300 ns. ... Keywords: Lunasin, molecular dynamics, amber, CLASICO, α-helix, β-turn, PTRAJ, RGD, RMSD ...

  2. A 1T Dynamic Random Access Memory Cell Based on Gated Thyristor with Surrounding Gate Structure for High Scalability.

    Science.gov (United States)

    Kim, Hyungjin; Kim, Sihyun; Kim, Hyun-Min; Lee, Kitae; Kim, Sangwan; Pak, Byung-Gook

    2018-09-01

    In this study, we investigate a one-transistor (1T) dynamic random access memory (DRAM) cell based on a gated-thyristor device utilizing voltage-driven bistability to enable high-speed operations. The structural feature of the surrounding gate using a sidewall provides high scalability with regard to constructing an array architecture of the proposed devices. In addition, the operation mechanism, I-V characteristics, DRAM operations, and bias dependence are analyzed using a commercial device simulator. Unlike conventional 1T DRAM cells utilizing the floating body effect, excess carriers which are required to be stored to make two different states are not generated but injected from the n+ cathode region, giving the device high-speed operation capabilities. The findings here indicate that the proposed DRAM cell offers distinct advantages in terms of scalability and high-speed operations.

  3. Scalable devices

    KAUST Repository

    Krüger, Jens J.

    2014-01-01

    In computer science in general and in particular the field of high performance computing and supercomputing the term scalable plays an important role. It indicates that a piece of hardware, a concept, an algorithm, or an entire system scales with the size of the problem, i.e., it can not only be used in a very specific setting but it\\'s applicable for a wide range of problems. From small scenarios to possibly very large settings. In this spirit, there exist a number of fixed areas of research on scalability. There are works on scalable algorithms, scalable architectures but what are scalable devices? In the context of this chapter, we are interested in a whole range of display devices, ranging from small scale hardware such as tablet computers, pads, smart-phones etc. up to large tiled display walls. What interests us mostly is not so much the hardware setup but mostly the visualization algorithms behind these display systems that scale from your average smart phone up to the largest gigapixel display walls.

  4. Overcoming the drawback of lower sense margin in tunnel FET based dynamic memory along with enhanced charge retention and scalability

    Science.gov (United States)

    Navlakha, Nupur; Kranti, Abhinav

    2017-11-01

    The work reports on the use of a planar tri-gate tunnel field effect transistor (TFET) to operate as dynamic memory at 85 °C with an enhanced sense margin (SM). Two symmetric gates (G1) aligned to the source at a partial region of intrinsic film result into better electrostatic control that regulates the read mechanism based on band-to-band tunneling, while the other gate (G2), positioned adjacent to the first front gate is responsible for charge storage and sustenance. The proposed architecture results in an enhanced SM of ˜1.2 μA μm-1 along with a longer retention time (RT) of ˜1.8 s at 85 °C, for a total length of 600 nm. The double gate architecture towards the source increases the tunneling current and also reduces short channel effects, enhancing SM and scalability, thereby overcoming the critical bottleneck faced by TFET based dynamic memories. The work also discusses the impact of overlap/underlap and interface charges on the performance of TFET based dynamic memory. Insights into device operation demonstrate that the choice of appropriate architecture and biases not only limit the trade-off between SM and RT, but also result in improved scalability with drain voltage and total length being scaled down to 0.8 V and 115 nm, respectively.

  5. Equation of state of dense plasmas: Orbital-free molecular dynamics as the limit of quantum molecular dynamics for high-Z elements

    Energy Technology Data Exchange (ETDEWEB)

    Danel, J.-F.; Blottiau, P.; Kazandjian, L.; Piron, R.; Torrent, M. [CEA, DAM, DIF, 91297 Arpajon (France)

    2014-10-15

    The applicability of quantum molecular dynamics to the calculation of the equation of state of a dense plasma is limited at high temperature by computational cost. Orbital-free molecular dynamics, based on a semiclassical approximation and possibly on a gradient correction, is a simulation method available at high temperature. For a high-Z element such as lutetium, we examine how orbital-free molecular dynamics applied to the equation of state of a dense plasma can be regarded as the limit of quantum molecular dynamics at high temperature. For the normal mass density and twice the normal mass density, we show that the pressures calculated with the quantum approach converge monotonically towards those calculated with the orbital-free approach; we observe a faster convergence when the orbital-free approach includes the gradient correction. We propose a method to obtain an equation of state reproducing quantum molecular dynamics results up to high temperatures where this approach cannot be directly implemented. With the results already obtained for low-Z plasmas, the present study opens the way for reproducing the quantum molecular dynamics pressure for all elements up to high temperatures.

  6. Scalable power selection method for wireless mesh networks

    CSIR Research Space (South Africa)

    Olwal, TO

    2009-01-01

    Full Text Available This paper addresses the problem of a scalable dynamic power control (SDPC) for wireless mesh networks (WMNs) based on IEEE 802.11 standards. An SDPC model that accounts for architectural complexities witnessed in multiple radios and hops...

  7. Next Generation Extended Lagrangian Quantum-based Molecular Dynamics

    Science.gov (United States)

    Negre, Christian

    2017-06-01

    A new framework for extended Lagrangian first-principles molecular dynamics simulations is presented, which overcomes shortcomings of regular, direct Born-Oppenheimer molecular dynamics, while maintaining important advantages of the unified extended Lagrangian formulation of density functional theory pioneered by Car and Parrinello three decades ago. The new framework allows, for the first time, energy conserving, linear-scaling Born-Oppenheimer molecular dynamics simulations, which is necessary to study larger and more realistic systems over longer simulation times than previously possible. Expensive, self-consinstent-field optimizations are avoided and normal integration time steps of regular, direct Born-Oppenheimer molecular dynamics can be used. Linear scaling electronic structure theory is presented using a graph-based approach that is ideal for parallel calculations on hybrid computer platforms. For the first time, quantum based Born-Oppenheimer molecular dynamics simulation is becoming a practically feasible approach in simulations of +100,000 atoms-representing a competitive alternative to classical polarizable force field methods. In collaboration with: Anders Niklasson, Los Alamos National Laboratory.

  8. A Secure, Scalable and Elastic Autonomic Computing Systems Paradigm: Supporting Dynamic Adaptation of Self-* Services from an Autonomic Cloud

    Directory of Open Access Journals (Sweden)

    Abdul Jaleel

    2018-05-01

    Full Text Available Autonomic computing embeds self-management features in software systems using external feedback control loops, i.e., autonomic managers. In existing models of autonomic computing, adaptive behaviors are defined at the design time, autonomic managers are statically configured, and the running system has a fixed set of self-* capabilities. An autonomic computing design should accommodate autonomic capability growth by allowing the dynamic configuration of self-* services, but this causes security and integrity issues. A secure, scalable and elastic autonomic computing system (SSE-ACS paradigm is proposed to address the runtime inclusion of autonomic managers, ensuring secure communication between autonomic managers and managed resources. Applying the SSE-ACS concept, a layered approach for the dynamic adaptation of self-* services is presented with an online ‘Autonomic_Cloud’ working as the middleware between Autonomic Managers (offering the self-* services and Autonomic Computing System (requiring the self-* services. A stock trading and forecasting system is used for simulation purposes. The security impact of the SSE-ACS paradigm is verified by testing possible attack cases over the autonomic computing system with single and multiple autonomic managers running on the same and different machines. The common vulnerability scoring system (CVSS metric shows a decrease in the vulnerability severity score from high (8.8 for existing ACS to low (3.9 for SSE-ACS. Autonomic managers are introduced into the system at runtime from the Autonomic_Cloud to test the scalability and elasticity. With elastic AMs, the system optimizes the Central Processing Unit (CPU share resulting in an improved execution time for business logic. For computing systems requiring the continuous support of self-management services, the proposed system achieves a significant improvement in security, scalability, elasticity, autonomic efficiency, and issue resolving time

  9. Thermally driven molecular linear motors - A molecular dynamics study

    DEFF Research Database (Denmark)

    Zambrano, Harvey A; Walther, Jens Honore; Jaffe, Richard Lawrence

    2009-01-01

    We conduct molecular dynamics simulations of a molecular linear motor consisting of coaxial carbon nanotubes with a long outer carbon nanotube confining and guiding the motion of an inner short, capsule-like nanotube. The simulations indicate that the motion of the capsule can be controlled by th...

  10. Scuba: scalable kernel-based gene prioritization.

    Science.gov (United States)

    Zampieri, Guido; Tran, Dinh Van; Donini, Michele; Navarin, Nicolò; Aiolli, Fabio; Sperduti, Alessandro; Valle, Giorgio

    2018-01-25

    The uncovering of genes linked to human diseases is a pressing challenge in molecular biology and precision medicine. This task is often hindered by the large number of candidate genes and by the heterogeneity of the available information. Computational methods for the prioritization of candidate genes can help to cope with these problems. In particular, kernel-based methods are a powerful resource for the integration of heterogeneous biological knowledge, however, their practical implementation is often precluded by their limited scalability. We propose Scuba, a scalable kernel-based method for gene prioritization. It implements a novel multiple kernel learning approach, based on a semi-supervised perspective and on the optimization of the margin distribution. Scuba is optimized to cope with strongly unbalanced settings where known disease genes are few and large scale predictions are required. Importantly, it is able to efficiently deal both with a large amount of candidate genes and with an arbitrary number of data sources. As a direct consequence of scalability, Scuba integrates also a new efficient strategy to select optimal kernel parameters for each data source. We performed cross-validation experiments and simulated a realistic usage setting, showing that Scuba outperforms a wide range of state-of-the-art methods. Scuba achieves state-of-the-art performance and has enhanced scalability compared to existing kernel-based approaches for genomic data. This method can be useful to prioritize candidate genes, particularly when their number is large or when input data is highly heterogeneous. The code is freely available at https://github.com/gzampieri/Scuba .

  11. Content-Aware Scalability-Type Selection for Rate Adaptation of Scalable Video

    Directory of Open Access Journals (Sweden)

    Tekalp A Murat

    2007-01-01

    Full Text Available Scalable video coders provide different scaling options, such as temporal, spatial, and SNR scalabilities, where rate reduction by discarding enhancement layers of different scalability-type results in different kinds and/or levels of visual distortion depend on the content and bitrate. This dependency between scalability type, video content, and bitrate is not well investigated in the literature. To this effect, we first propose an objective function that quantifies flatness, blockiness, blurriness, and temporal jerkiness artifacts caused by rate reduction by spatial size, frame rate, and quantization parameter scaling. Next, the weights of this objective function are determined for different content (shot types and different bitrates using a training procedure with subjective evaluation. Finally, a method is proposed for choosing the best scaling type for each temporal segment that results in minimum visual distortion according to this objective function given the content type of temporal segments. Two subjective tests have been performed to validate the proposed procedure for content-aware selection of the best scalability type on soccer videos. Soccer videos scaled from 600 kbps to 100 kbps by the proposed content-aware selection of scalability type have been found visually superior to those that are scaled using a single scalability option over the whole sequence.

  12. Scalable and fast heterogeneous molecular simulation with predictive parallelization schemes

    International Nuclear Information System (INIS)

    Guzman, Horacio V.; Junghans, Christoph; Kremer, Kurt; Stuehn, Torsten

    2017-01-01

    Multiscale and inhomogeneous molecular systems are challenging topics in the field of molecular simulation. In particular, modeling biological systems in the context of multiscale simulations and exploring material properties are driving a permanent development of new simulation methods and optimization algorithms. In computational terms, those methods require parallelization schemes that make a productive use of computational resources for each simulation and from its genesis. Here, we introduce the heterogeneous domain decomposition approach, which is a combination of an heterogeneity-sensitive spatial domain decomposition with an a priori rearrangement of subdomain walls. Within this approach and paper, the theoretical modeling and scaling laws for the force computation time are proposed and studied as a function of the number of particles and the spatial resolution ratio. We also show the new approach capabilities, by comparing it to both static domain decomposition algorithms and dynamic load-balancing schemes. Specifically, two representative molecular systems have been simulated and compared to the heterogeneous domain decomposition proposed in this work. Finally, these two systems comprise an adaptive resolution simulation of a biomolecule solvated in water and a phase-separated binary Lennard-Jones fluid.

  13. Scalable and fast heterogeneous molecular simulation with predictive parallelization schemes

    Science.gov (United States)

    Guzman, Horacio V.; Junghans, Christoph; Kremer, Kurt; Stuehn, Torsten

    2017-11-01

    Multiscale and inhomogeneous molecular systems are challenging topics in the field of molecular simulation. In particular, modeling biological systems in the context of multiscale simulations and exploring material properties are driving a permanent development of new simulation methods and optimization algorithms. In computational terms, those methods require parallelization schemes that make a productive use of computational resources for each simulation and from its genesis. Here, we introduce the heterogeneous domain decomposition approach, which is a combination of an heterogeneity-sensitive spatial domain decomposition with an a priori rearrangement of subdomain walls. Within this approach, the theoretical modeling and scaling laws for the force computation time are proposed and studied as a function of the number of particles and the spatial resolution ratio. We also show the new approach capabilities, by comparing it to both static domain decomposition algorithms and dynamic load-balancing schemes. Specifically, two representative molecular systems have been simulated and compared to the heterogeneous domain decomposition proposed in this work. These two systems comprise an adaptive resolution simulation of a biomolecule solvated in water and a phase-separated binary Lennard-Jones fluid.

  14. Introduction to Molecular Dynamics and Accelerated Molecular Dynamics

    International Nuclear Information System (INIS)

    Perez, Danny

    2012-01-01

    We first introduce classical molecular dynamics (MD) simulations. We discuss their main constituents - the interatomic potentials, the boundary conditions, and the integrators - and the discuss the various ensembles that can be sampled. We discuss the strengths and weaknesses of MD, specifically in terms of time and length-scales. We then move on to discuss accelerated MD (AMD) methods, techniques that were designed to circumvent the timescale limitations of MD for rare event systems. The different methods are introduced and examples of use given.

  15. NGLview-interactive molecular graphics for Jupyter notebooks.

    Science.gov (United States)

    Nguyen, Hai; Case, David A; Rose, Alexander S

    2018-04-01

    NGLview is a Jupyter/IPython widget to interactively view molecular structures as well as trajectories from molecular dynamics simulations. Fast and scalable molecular graphics are provided through the NGL Viewer. The widget supports showing data from the file-system, online data bases and from objects of many popular analysis libraries including mdanalysis, mdtraj, pytraj, rdkit and more. The source code is freely available under the MIT license at https://github.com/arose/nglview. Python packages are available from PyPI and bioconda. NGLview uses Python on the server-side and JavaScript on the client. The integration with Jupyter is done through the ipywidgets package. The NGL Viewer is embedded client-side to provide WebGL accelerated molecular graphics. asr.moin@gmail.com.

  16. Current-driven dynamics in molecular-scale devices

    International Nuclear Information System (INIS)

    Seideman, Tamar

    2003-01-01

    We review recent theoretical work on current-triggered processes in molecular-scale devices - a field at the interface between solid state physics and chemical dynamics with potential applications in diverse areas, including artificial molecular machines, unimolecular transport, surface nanochemistry and nanolithography. The qualitative physics underlying current-triggered dynamics is first discussed and placed in context with several well-studied phenomena with which it shares aspects. A theory for modelling these dynamics is next formulated within a time-dependent scattering approach. Our end result provides useful insight into the system properties that determine the reaction outcome as well as a computationally convenient framework for numerical realization. The theory is applied to study single-molecule surface reactions induced by a scanning tunnelling microscope and current-triggered dynamics in single-molecule transistors. We close with a discussion of several potential applications of current-induced dynamics in molecular devices and several opportunities for future research. (topical review)

  17. Cooperative Scalable Moving Continuous Query Processing

    DEFF Research Database (Denmark)

    Li, Xiaohui; Karras, Panagiotis; Jensen, Christian S.

    2012-01-01

    of the global view and handle the majority of the workload. Meanwhile, moving clients, having basic memory and computation resources, handle small portions of the workload. This model is further enhanced by dynamic region allocation and grid size adjustment mechanisms that reduce the communication...... and computation cost for both servers and clients. An experimental study demonstrates that our approaches offer better scalability than competitors...

  18. Molecular Dynamics Studies of Nanofluidic Devices

    DEFF Research Database (Denmark)

    Zambrano Rodriguez, Harvey Alexander

    of such devices. Computational nanofluidics complements experimental studies by providing detailed spatial and temporal information of the nanosystem. In this thesis, we conduct molecular dynamics simulations to study basic nanoscale devices. We focus our studies on the understanding of transport mechanism...... to drive fluids and solids at the nanoscale. Specifically, we present the results of three different research projects. Throughout the first part of this thesis, we include a comprenhensive introduction to computational nanofluidics and to molecular simulations, and describe the molecular dynamics...... in opposite direction to the imposed thermal gradient also we measure higher velocities as higher thermal gradients are imposed. Secondly, we present an atomistic analysis of a molecular linear motor fabricated of coaxial carbon nanotubes and powered by thermal gradients. The MD simulation results indicate...

  19. Cascaded column generation for scalable predictive demand side management

    NARCIS (Netherlands)

    Toersche, Hermen; Molderink, Albert; Hurink, Johann L.; Smit, Gerardus Johannes Maria

    2014-01-01

    We propose a nested Dantzig-Wolfe decomposition, combined with dynamic programming, for the distributed scheduling of a large heterogeneous fleet of residential appliances with nonlinear behavior. A cascaded column generation approach gives a scalable optimization strategy, provided that the problem

  20. Neighborhood communication paradigm to increase scalability in large-scale dynamic scientific applications

    KAUST Repository

    Ovcharenko, Aleksandr

    2012-03-01

    This paper introduces a general-purpose communication package built on top of MPI which is aimed at improving inter-processor communications independently of the supercomputer architecture being considered. The package is developed to support parallel applications that rely on computation characterized by large number of messages of various sizes, often small, that are focused within processor neighborhoods. In some cases, such as solvers having static mesh partitions, the number and size of messages are known a priori. However, in other cases such as mesh adaptation, the messages evolve and vary in number and size and include the dynamic movement of partition objects. The current package provides a utility for dynamic applications based on two key attributes that are: (i) explicit consideration of the neighborhood communication pattern to avoid many-to-many calls and also to reduce the number of collective calls to a minimum, and (ii) use of non-blocking MPI functions along with message packing to manage message flow control and reduce the number and time of communication calls. The test application demonstrated is parallel unstructured mesh adaptation. Results on IBM Blue Gene/P and Cray XE6 computers show that the use of neighborhood-based communication control leads to scalable results when executing generally imbalanced mesh adaptation runs. © 2011 Elsevier B.V. All rights reserved.

  1. Theoretical Concepts in Molecular Photodissociation Dynamics

    DEFF Research Database (Denmark)

    Henriksen, Niels Engholm

    1995-01-01

    This chapter contains sections titled: Introduction Quantum Dynamics of Molecular Photofragmentation The Total Reaction Probability Final Product Distributions Time-Independent Approach, Stationary Scattering States Gaussian Wave Packet Dynamics Wigner Phase Space Representation The Diatomic...

  2. First principles molecular dynamics without self-consistent field optimization

    International Nuclear Information System (INIS)

    Souvatzis, Petros; Niklasson, Anders M. N.

    2014-01-01

    We present a first principles molecular dynamics approach that is based on time-reversible extended Lagrangian Born-Oppenheimer molecular dynamics [A. M. N. Niklasson, Phys. Rev. Lett. 100, 123004 (2008)] in the limit of vanishing self-consistent field optimization. The optimization-free dynamics keeps the computational cost to a minimum and typically provides molecular trajectories that closely follow the exact Born-Oppenheimer potential energy surface. Only one single diagonalization and Hamiltonian (or Fockian) construction are required in each integration time step. The proposed dynamics is derived for a general free-energy potential surface valid at finite electronic temperatures within hybrid density functional theory. Even in the event of irregular functional behavior that may cause a dynamical instability, the optimization-free limit represents a natural starting guess for force calculations that may require a more elaborate iterative electronic ground state optimization. Our optimization-free dynamics thus represents a flexible theoretical framework for a broad and general class of ab initio molecular dynamics simulations

  3. Genetic algorithms and genetic programming for multiscale modeling: Applications in materials science and chemistry and advances in scalability

    Science.gov (United States)

    Sastry, Kumara Narasimha

    2007-03-01

    Effective and efficient rnultiscale modeling is essential to advance both the science and synthesis in a, wide array of fields such as physics, chemistry, materials science; biology, biotechnology and pharmacology. This study investigates the efficacy and potential of rising genetic algorithms for rnultiscale materials modeling and addresses some of the challenges involved in designing competent algorithms that solve hard problems quickly, reliably and accurately. In particular, this thesis demonstrates the use of genetic algorithms (GAs) and genetic programming (GP) in multiscale modeling with the help of two non-trivial case studies in materials science and chemistry. The first case study explores the utility of genetic programming (GP) in multi-timescaling alloy kinetics simulations. In essence, GP is used to bridge molecular dynamics and kinetic Monte Carlo methods to span orders-of-magnitude in simulation time. Specifically, GP is used to regress symbolically an inline barrier function from a limited set of molecular dynamics simulations to enable kinetic Monte Carlo that simulate seconds of real time. Results on a non-trivial example of vacancy-assisted migration on a surface of a face-centered cubic (fcc) Copper-Cobalt (CuxCo 1-x) alloy show that GP predicts all barriers with 0.1% error from calculations for less than 3% of active configurations, independent of type of potentials used to obtain the learning set of barriers via molecular dynamics. The resulting method enables 2--9 orders-of-magnitude increase in real-time dynamics simulations taking 4--7 orders-of-magnitude less CPU time. The second case study presents the application of multiobjective genetic algorithms (MOGAs) in multiscaling quantum chemistry simulations. Specifically, MOGAs are used to bridge high-level quantum chemistry and semiempirical methods to provide accurate representation of complex molecular excited-state and ground-state behavior. Results on ethylene and benzene---two common

  4. Molecular dynamics and diffusion a compilation

    CERN Document Server

    Fisher, David

    2013-01-01

    The molecular dynamics technique was developed in the 1960s as the outgrowth of attempts to model complicated systems by using either a) direct physical simulation or (following the great success of Monte Carlo methods) by b) using computer techniques. Computer simulation soon won out over clumsy physical simulation, and the ever-increasing speed and sophistication of computers has naturally made molecular dynamics simulation into a more and more successful technique. One of its most popular applications is the study of diffusion, and some experts now even claim that molecular dynamics simulation is, in the case of situations involving well-characterised elements and structures, more accurate than experimental measurement. The present double volume includes a compilation (over 600 items) of predicted solid-state diffusion data, for all of the major materials groups, dating back nearly four decades. The double volume also includes some original papers: "Determination of the Activation Energy for Formation and ...

  5. Extended Lagrangian Excited State Molecular Dynamics.

    Science.gov (United States)

    Bjorgaard, J A; Sheppard, D; Tretiak, S; Niklasson, A M N

    2018-02-13

    An extended Lagrangian framework for excited state molecular dynamics (XL-ESMD) using time-dependent self-consistent field theory is proposed. The formulation is a generalization of the extended Lagrangian formulations for ground state Born-Oppenheimer molecular dynamics [Phys. Rev. Lett. 2008 100, 123004]. The theory is implemented, demonstrated, and evaluated using a time-dependent semiempirical model, though it should be generally applicable to ab initio theory. The simulations show enhanced energy stability and a significantly reduced computational cost associated with the iterative solutions of both the ground state and the electronically excited states. Relaxed convergence criteria can therefore be used both for the self-consistent ground state optimization and for the iterative subspace diagonalization of the random phase approximation matrix used to calculate the excited state transitions. The XL-ESMD approach is expected to enable numerically efficient excited state molecular dynamics for such methods as time-dependent Hartree-Fock (TD-HF), Configuration Interactions Singles (CIS), and time-dependent density functional theory (TD-DFT).

  6. Advances in molecular vibrations and collision dynamics molecular clusters

    CERN Document Server

    Bacic, Zatko

    1998-01-01

    This volume focuses on molecular clusters, bound by van der Waals interactions and hydrogen bonds. Twelve chapters review a wide range of recent theoretical and experimental advances in the areas of cluster vibrations, spectroscopy, and reaction dynamics. The authors are leading experts, who have made significant contributions to these topics.The first chapter describes exciting results and new insights in the solvent effects on the short-time photo fragmentation dynamics of small molecules, obtained by combining heteroclusters with femtosecond laser excitation. The second is on theoretical work on effects of single solvent (argon) atom on the photodissociation dynamics of the solute H2O molecule. The next two chapters cover experimental and theoretical aspects of the energetics and vibrations of small clusters. Chapter 5 describes diffusion quantum Monte Carlo calculations and non additive three-body potential terms in molecular clusters. The next six chapters deal with hydrogen-bonded clusters, refle...

  7. Hydrogen Bond Dynamics in Aqueous Solutions: Ab initio Molecular ...

    Indian Academy of Sciences (India)

    Rate equation for the decay of CHB(t) · Definition of Hydrogen Bonds · Results of Molecular Dynamics · Dynamics of anion-water and water-water hydrogen bonds · Structural relaxation of anion-water & water-water H-bonds · Ab initio Molecular Dynamics : · Slide 14 · Dynamics of hydrogen bonds : CPMD results · Slide 16.

  8. Non-adiabatic molecular dynamic simulations of opening reaction of molecular junctions

    Czech Academy of Sciences Publication Activity Database

    Zobač, Vladimír; Lewis, J.P.; Jelínek, Pavel

    2016-01-01

    Roč. 27, č. 28 (2016), 1-8, č. článku 285202. ISSN 0957-4484 R&D Projects: GA ČR(CZ) GA14-02079S Institutional support: RVO:68378271 Keywords : non-adiabatic molecular dynamics * molecular junctions * molecular switches * DFT Subject RIV: BM - Solid Matter Physics ; Magnetism Impact factor: 3.440, year: 2016

  9. Visualizing Energy on Target: Molecular Dynamics Simulations

    Science.gov (United States)

    2017-12-01

    ARL-TR-8234 ● DEC 2017 US Army Research Laboratory Visualizing Energy on Target: Molecular Dynamics Simulations by DeCarlos E...return it to the originator. ARL-TR-8234● DEC 2017 US Army Research Laboratory Visualizing Energy on Target: Molecular Dynamics...REPORT TYPE Technical Report 3. DATES COVERED (From - To) 1 October 2015–30 September 2016 4. TITLE AND SUBTITLE Visualizing Energy on Target

  10. Ultracold molecules: vehicles to scalable quantum information processing

    International Nuclear Information System (INIS)

    Brickman Soderberg, Kathy-Anne; Gemelke, Nathan; Chin Cheng

    2009-01-01

    In this paper, we describe a novel scheme to implement scalable quantum information processing using Li-Cs molecular states to entangle 6 Li and 133 Cs ultracold atoms held in independent optical lattices. The 6 Li atoms will act as quantum bits to store information and 133 Cs atoms will serve as messenger bits that aid in quantum gate operations and mediate entanglement between distant qubit atoms. Each atomic species is held in a separate optical lattice and the atoms can be overlapped by translating the lattices with respect to each other. When the messenger and qubit atoms are overlapped, targeted single-spin operations and entangling operations can be performed by coupling the atomic states to a molecular state with radio-frequency pulses. By controlling the frequency and duration of the radio-frequency pulses, entanglement can be either created or swapped between a qubit messenger pair. We estimate operation fidelities for entangling two distant qubits and discuss scalability of this scheme and constraints on the optical lattice lasers. Finally we demonstrate experimental control of the optical potentials sufficient to translate atoms in the lattice.

  11. Scalable Algorithms for Adaptive Statistical Designs

    Directory of Open Access Journals (Sweden)

    Robert Oehmke

    2000-01-01

    Full Text Available We present a scalable, high-performance solution to multidimensional recurrences that arise in adaptive statistical designs. Adaptive designs are an important class of learning algorithms for a stochastic environment, and we focus on the problem of optimally assigning patients to treatments in clinical trials. While adaptive designs have significant ethical and cost advantages, they are rarely utilized because of the complexity of optimizing and analyzing them. Computational challenges include massive memory requirements, few calculations per memory access, and multiply-nested loops with dynamic indices. We analyze the effects of various parallelization options, and while standard approaches do not work well, with effort an efficient, highly scalable program can be developed. This allows us to solve problems thousands of times more complex than those solved previously, which helps make adaptive designs practical. Further, our work applies to many other problems involving neighbor recurrences, such as generalized string matching.

  12. Nonadiabatic electron wavepacket dynamics behind molecular autoionization

    Science.gov (United States)

    Matsuoka, Takahide; Takatsuka, Kazuo

    2018-01-01

    A theoretical method for real-time dynamics of nonadiabatic reorganization of electronic configurations in molecules is developed, with dual aim that the intramolecular electron dynamics can be probed by means of direct and/or indirect photoionizations and that the physical origins behind photoionization signals attained in the time domain can be identified in terms of the language of time-dependent quantum chemistry. In doing so, we first formulate and implement a new computational scheme for nonadiabatic electron dynamics associated with molecular ionization, which well fits in the general theory of nonadiabatic electron dynamics. In this method, the total nonadiabatic electron wavepackets are propagated in time directly with complex natural orbitals without referring to Hartree-Fock molecular orbitals, and the amount of electron flux from a molecular region leading to ionization is evaluated in terms of the relevant complex natural orbitals. In the second half of this paper, we apply the method to electron dynamics in the elementary processes consisting of the Auger decay to demonstrate the methodological significance. An illustrative example is taken from an Auger decay starting from the 2a1 orbital hole-state of H2O+. The roles of nuclear momentum (kinetic) couplings in electronic-state mixing during the decay process are analyzed in terms of complex natural orbitals, which are schematically represented in the conventional language of molecular symmetry of the Hartree-Fock orbitals.

  13. Ultrafast molecular dynamics illuminated with synchrotron radiation

    International Nuclear Information System (INIS)

    Bozek, John D.; Miron, Catalin

    2015-01-01

    Highlights: • Ultrafast molecular dynamics probed with synchrotron radiation. • Core-excitation as probe of ultrafast dynamics through core-hole lifetime. • Review of experimental and theoretical methods in ultrafast dynamics using core-level excitation. - Abstract: Synchrotron radiation is a powerful tool for studying molecular dynamics in small molecules in spite of the absence of natural matching between the X-ray pulse duration and the time scale of nuclear motion. Promoting core level electrons to unoccupied molecular orbitals simultaneously initiates two ultrafast processes, nuclear dynamics on the potential energy surfaces of the highly excited neutral intermediate state of the molecule on the one hand and an ultrafast electronic decay of the intermediate excited state to a cationic final state, characterized by a core hole lifetime. The similar time scales of these processes enable core excited pump-probe-type experiments to be performed with long duration X-ray pulses from a synchrotron source. Recent results obtained at the PLIEADES beamline concerning ultrafast dissociation of core excited states and molecular potential energy curve mapping facilitated by changes in the geometry of the short-lived intermediate core excited state are reviewed. High brightness X-ray beams combined with state-of-the art electron and ion-electron coincidence spectrometers and highly sophisticated theoretical methods are required to conduct these experiments and to achieve a full understanding of the experimental results.

  14. Rheology via nonequilibrium molecular dynamics

    International Nuclear Information System (INIS)

    Hoover, W.G.

    1982-10-01

    The equilibrium molecular dynamics formulated by Newton, Lagrange, and Hamilton has been modified in order to simulate rheologial molecular flows with fast computers. This modified Nonequilibrium Molecular Dynamics (NEMD) has been applied to fluid and solid deformations, under both homogeneous and shock conditions, as well as to the transport of heat. The irreversible heating associated with dissipation could be controlled by carrying out isothermal NEMD calculations. The new isothermal NEMD equations of motion are consistent with Gauss' 1829 Least-Constraint principle as well as certain microscopic equilibrium and nonequilibrium statistical formulations due to Gibbs and Boltzmann. Application of isothermal NEMD revealed high-frequency and high-strain-rate behavior for simple fluids which resembled the behavior of polymer solutions and melts at lower frequencies and strain rates. For solids NEMD produces plastic flows consistent with experimental observations at much lower strain rates. The new nonequilibrium methods also suggest novel formulations of thermodynamics in nonequilibrium systems and shed light on the failure of the Principle of Material Frame Indifference

  15. First-principles molecular dynamics for metals

    International Nuclear Information System (INIS)

    Fernando, G.W.; Qian, G.; Weinert, M.; Davenport, J.W.

    1989-01-01

    A Car-Parrinello-type first-principles molecular-dynamics approach capable of treating the partial occupancy of electronic states that occurs at the Fermi level in a metal is presented. The algorithms used to study metals are both simple and computationally efficient. We also discuss the connection between ordinary electronic-structure calculations and molecular-dynamics simulations as well as the role of Brillouin-zone sampling. This extension should be useful not only for metallic solids but also for solids that become metals in their liquid and/or amorphous phases

  16. How Dynamic Visualization Technology Can Support Molecular Reasoning

    Science.gov (United States)

    Levy, Dalit

    2013-01-01

    This paper reports the results of a study aimed at exploring the advantages of dynamic visualization for the development of better understanding of molecular processes. We designed a technology-enhanced curriculum module in which high school chemistry students conduct virtual experiments with dynamic molecular visualizations of solid, liquid, and…

  17. A Numerical Study of Scalable Cardiac Electro-Mechanical Solvers on HPC Architectures

    Directory of Open Access Journals (Sweden)

    Piero Colli Franzone

    2018-04-01

    Full Text Available We introduce and study some scalable domain decomposition preconditioners for cardiac electro-mechanical 3D simulations on parallel HPC (High Performance Computing architectures. The electro-mechanical model of the cardiac tissue is composed of four coupled sub-models: (1 the static finite elasticity equations for the transversely isotropic deformation of the cardiac tissue; (2 the active tension model describing the dynamics of the intracellular calcium, cross-bridge binding and myofilament tension; (3 the anisotropic Bidomain model describing the evolution of the intra- and extra-cellular potentials in the deforming cardiac tissue; and (4 the ionic membrane model describing the dynamics of ionic currents, gating variables, ionic concentrations and stretch-activated channels. This strongly coupled electro-mechanical model is discretized in time with a splitting semi-implicit technique and in space with isoparametric finite elements. The resulting scalable parallel solver is based on Multilevel Additive Schwarz preconditioners for the solution of the Bidomain system and on BDDC preconditioned Newton-Krylov solvers for the non-linear finite elasticity system. The results of several 3D parallel simulations show the scalability of both linear and non-linear solvers and their application to the study of both physiological excitation-contraction cardiac dynamics and re-entrant waves in the presence of different mechano-electrical feedbacks.

  18. Physical adsorption and molecular dynamics

    International Nuclear Information System (INIS)

    Cohan, N.V.

    1981-01-01

    Some aspects of noble gases adsorption (except He) on graphite substracts are reviewed. Experimental results from this adsorption are analyzed and compared with molecular dynamics calculations. (L.C.) [pt

  19. A framework for scalable parameter estimation of gene circuit models using structural information

    KAUST Repository

    Kuwahara, Hiroyuki

    2013-06-21

    Motivation: Systematic and scalable parameter estimation is a key to construct complex gene regulatory models and to ultimately facilitate an integrative systems biology approach to quantitatively understand the molecular mechanisms underpinning gene regulation. Results: Here, we report a novel framework for efficient and scalable parameter estimation that focuses specifically on modeling of gene circuits. Exploiting the structure commonly found in gene circuit models, this framework decomposes a system of coupled rate equations into individual ones and efficiently integrates them separately to reconstruct the mean time evolution of the gene products. The accuracy of the parameter estimates is refined by iteratively increasing the accuracy of numerical integration using the model structure. As a case study, we applied our framework to four gene circuit models with complex dynamics based on three synthetic datasets and one time series microarray data set. We compared our framework to three state-of-the-art parameter estimation methods and found that our approach consistently generated higher quality parameter solutions efficiently. Although many general-purpose parameter estimation methods have been applied for modeling of gene circuits, our results suggest that the use of more tailored approaches to use domain-specific information may be a key to reverse engineering of complex biological systems. The Author 2013.

  20. A framework for scalable parameter estimation of gene circuit models using structural information

    KAUST Repository

    Kuwahara, Hiroyuki; Fan, Ming; Wang, Suojin; Gao, Xin

    2013-01-01

    Motivation: Systematic and scalable parameter estimation is a key to construct complex gene regulatory models and to ultimately facilitate an integrative systems biology approach to quantitatively understand the molecular mechanisms underpinning gene regulation. Results: Here, we report a novel framework for efficient and scalable parameter estimation that focuses specifically on modeling of gene circuits. Exploiting the structure commonly found in gene circuit models, this framework decomposes a system of coupled rate equations into individual ones and efficiently integrates them separately to reconstruct the mean time evolution of the gene products. The accuracy of the parameter estimates is refined by iteratively increasing the accuracy of numerical integration using the model structure. As a case study, we applied our framework to four gene circuit models with complex dynamics based on three synthetic datasets and one time series microarray data set. We compared our framework to three state-of-the-art parameter estimation methods and found that our approach consistently generated higher quality parameter solutions efficiently. Although many general-purpose parameter estimation methods have been applied for modeling of gene circuits, our results suggest that the use of more tailored approaches to use domain-specific information may be a key to reverse engineering of complex biological systems. The Author 2013.

  1. Thomas-Fermi molecular dynamics

    International Nuclear Information System (INIS)

    Clerouin, J.; Pollock, E.L.; Zerah, G.

    1992-01-01

    A three-dimensional density-functional molecular-dynamics code is developed for the Thomas-Fermi density functional as a prototype for density functionals using only the density. Following Car and Parrinello [Phys. Rev. Lett. 55, 2471 (1985)], the electronic density is treated as a dynamical variable. The electronic densities are verified against a multi-ion Thomas-Fermi algorithm due to Parker [Phys. Rev. A 38, 2205 (1988)]. As an initial application, the effect of electronic polarization in enhancing ionic diffusion in strongly coupled plasmas is demonstrated

  2. Molecular dynamics for dense matter

    International Nuclear Information System (INIS)

    Maruyama, Toshiki; Chiba, Satoshi; Watanabe, Gentaro

    2012-01-01

    We review a molecular dynamics method for nucleon many-body systems called quantum molecular dynamics (QMD), and our studies using this method. These studies address the structure and the dynamics of nuclear matter relevant to neutron star crusts, supernova cores, and heavy-ion collisions. A key advantage of QMD is that we can study dynamical processes of nucleon many-body systems without any assumptions about the nuclear structure. First, we focus on the inhomogeneous structures of low-density nuclear matter consisting not only of spherical nuclei but also of nuclear “pasta”, i.e., rod-like and slab-like nuclei. We show that pasta phases can appear in the ground and equilibrium states of nuclear matter without assuming nuclear shape. Next, we show our simulation of compression of nuclear matter which corresponds to the collapsing stage of supernovae. With the increase in density, a crystalline solid of spherical nuclei changes to a triangular lattice of rods by connecting neighboring nuclei. Finally, we discuss fragment formation in expanding nuclear matter. Our results suggest that a generally accepted scenario based on the liquid–gas phase transition is not plausible at lower temperatures. (author)

  3. Molecular dynamics for dense matter

    Science.gov (United States)

    Maruyama, Toshiki; Watanabe, Gentaro; Chiba, Satoshi

    2012-08-01

    We review a molecular dynamics method for nucleon many-body systems called quantum molecular dynamics (QMD), and our studies using this method. These studies address the structure and the dynamics of nuclear matter relevant to neutron star crusts, supernova cores, and heavy-ion collisions. A key advantage of QMD is that we can study dynamical processes of nucleon many-body systems without any assumptions about the nuclear structure. First, we focus on the inhomogeneous structures of low-density nuclear matter consisting not only of spherical nuclei but also of nuclear "pasta", i.e., rod-like and slab-like nuclei. We show that pasta phases can appear in the ground and equilibrium states of nuclear matter without assuming nuclear shape. Next, we show our simulation of compression of nuclear matter which corresponds to the collapsing stage of supernovae. With the increase in density, a crystalline solid of spherical nuclei changes to a triangular lattice of rods by connecting neighboring nuclei. Finally, we discuss fragment formation in expanding nuclear matter. Our results suggest that a generally accepted scenario based on the liquid-gas phase transition is not plausible at lower temperatures.

  4. Water Dynamics in Protein Hydration Shells: The Molecular Origins of the Dynamical Perturbation

    Science.gov (United States)

    2014-01-01

    Protein hydration shell dynamics play an important role in biochemical processes including protein folding, enzyme function, and molecular recognition. We present here a comparison of the reorientation dynamics of individual water molecules within the hydration shell of a series of globular proteins: acetylcholinesterase, subtilisin Carlsberg, lysozyme, and ubiquitin. Molecular dynamics simulations and analytical models are used to access site-resolved information on hydration shell dynamics and to elucidate the molecular origins of the dynamical perturbation of hydration shell water relative to bulk water. We show that all four proteins have very similar hydration shell dynamics, despite their wide range of sizes and functions, and differing secondary structures. We demonstrate that this arises from the similar local surface topology and surface chemical composition of the four proteins, and that such local factors alone are sufficient to rationalize the hydration shell dynamics. We propose that these conclusions can be generalized to a wide range of globular proteins. We also show that protein conformational fluctuations induce a dynamical heterogeneity within the hydration layer. We finally address the effect of confinement on hydration shell dynamics via a site-resolved analysis and connect our results to experiments via the calculation of two-dimensional infrared spectra. PMID:24479585

  5. Scalable Frequent Subgraph Mining

    KAUST Repository

    Abdelhamid, Ehab

    2017-06-19

    A graph is a data structure that contains a set of nodes and a set of edges connecting these nodes. Nodes represent objects while edges model relationships among these objects. Graphs are used in various domains due to their ability to model complex relations among several objects. Given an input graph, the Frequent Subgraph Mining (FSM) task finds all subgraphs with frequencies exceeding a given threshold. FSM is crucial for graph analysis, and it is an essential building block in a variety of applications, such as graph clustering and indexing. FSM is computationally expensive, and its existing solutions are extremely slow. Consequently, these solutions are incapable of mining modern large graphs. This slowness is caused by the underlying approaches of these solutions which require finding and storing an excessive amount of subgraph matches. This dissertation proposes a scalable solution for FSM that avoids the limitations of previous work. This solution is composed of four components. The first component is a single-threaded technique which, for each candidate subgraph, needs to find only a minimal number of matches. The second component is a scalable parallel FSM technique that utilizes a novel two-phase approach. The first phase quickly builds an approximate search space, which is then used by the second phase to optimize and balance the workload of the FSM task. The third component focuses on accelerating frequency evaluation, which is a critical step in FSM. To do so, a machine learning model is employed to predict the type of each graph node, and accordingly, an optimized method is selected to evaluate that node. The fourth component focuses on mining dynamic graphs, such as social networks. To this end, an incremental index is maintained during the dynamic updates. Only this index is processed and updated for the majority of graph updates. Consequently, search space is significantly pruned and efficiency is improved. The empirical evaluation shows that the

  6. Coalescent: an open-source and scalable framework for exact calculations in coalescent theory

    Science.gov (United States)

    2012-01-01

    Background Currently, there is no open-source, cross-platform and scalable framework for coalescent analysis in population genetics. There is no scalable GUI based user application either. Such a framework and application would not only drive the creation of more complex and realistic models but also make them truly accessible. Results As a first attempt, we built a framework and user application for the domain of exact calculations in coalescent analysis. The framework provides an API with the concepts of model, data, statistic, phylogeny, gene tree and recursion. Infinite-alleles and infinite-sites models are considered. It defines pluggable computations such as counting and listing all the ancestral configurations and genealogies and computing the exact probability of data. It can visualize a gene tree, trace and visualize the internals of the recursion algorithm for further improvement and attach dynamically a number of output processors. The user application defines jobs in a plug-in like manner so that they can be activated, deactivated, installed or uninstalled on demand. Multiple jobs can be run and their inputs edited. Job inputs are persisted across restarts and running jobs can be cancelled where applicable. Conclusions Coalescent theory plays an increasingly important role in analysing molecular population genetic data. Models involved are mathematically difficult and computationally challenging. An open-source, scalable framework that lets users immediately take advantage of the progress made by others will enable exploration of yet more difficult and realistic models. As models become more complex and mathematically less tractable, the need for an integrated computational approach is obvious. Object oriented designs, though has upfront costs, are practical now and can provide such an integrated approach. PMID:23033878

  7. Coalescent: an open-source and scalable framework for exact calculations in coalescent theory

    Directory of Open Access Journals (Sweden)

    Tewari Susanta

    2012-10-01

    Full Text Available Abstract Background Currently, there is no open-source, cross-platform and scalable framework for coalescent analysis in population genetics. There is no scalable GUI based user application either. Such a framework and application would not only drive the creation of more complex and realistic models but also make them truly accessible. Results As a first attempt, we built a framework and user application for the domain of exact calculations in coalescent analysis. The framework provides an API with the concepts of model, data, statistic, phylogeny, gene tree and recursion. Infinite-alleles and infinite-sites models are considered. It defines pluggable computations such as counting and listing all the ancestral configurations and genealogies and computing the exact probability of data. It can visualize a gene tree, trace and visualize the internals of the recursion algorithm for further improvement and attach dynamically a number of output processors. The user application defines jobs in a plug-in like manner so that they can be activated, deactivated, installed or uninstalled on demand. Multiple jobs can be run and their inputs edited. Job inputs are persisted across restarts and running jobs can be cancelled where applicable. Conclusions Coalescent theory plays an increasingly important role in analysing molecular population genetic data. Models involved are mathematically difficult and computationally challenging. An open-source, scalable framework that lets users immediately take advantage of the progress made by others will enable exploration of yet more difficult and realistic models. As models become more complex and mathematically less tractable, the need for an integrated computational approach is obvious. Object oriented designs, though has upfront costs, are practical now and can provide such an integrated approach.

  8. Molecular dynamics with deterministic and stochastic numerical methods

    CERN Document Server

    Leimkuhler, Ben

    2015-01-01

    This book describes the mathematical underpinnings of algorithms used for molecular dynamics simulation, including both deterministic and stochastic numerical methods. Molecular dynamics is one of the most versatile and powerful methods of modern computational science and engineering and is used widely in chemistry, physics, materials science and biology. Understanding the foundations of numerical methods means knowing how to select the best one for a given problem (from the wide range of techniques on offer) and how to create new, efficient methods to address particular challenges as they arise in complex applications.  Aimed at a broad audience, this book presents the basic theory of Hamiltonian mechanics and stochastic differential equations, as well as topics including symplectic numerical methods, the handling of constraints and rigid bodies, the efficient treatment of Langevin dynamics, thermostats to control the molecular ensemble, multiple time-stepping, and the dissipative particle dynamics method...

  9. Molecular ions, Rydberg spectroscopy and dynamics

    International Nuclear Information System (INIS)

    Jungen, Ch.

    2015-01-01

    Ion spectroscopy, Rydberg spectroscopy and molecular dynamics are closely related subjects. Multichannel quantum defect theory is a theoretical approach which draws on this close relationship and thereby becomes a powerful tool for the study of systems consisting of a positively charged molecular ion core interacting with an electron which may be loosely bound or freely scattering

  10. Molecular ions, Rydberg spectroscopy and dynamics

    Energy Technology Data Exchange (ETDEWEB)

    Jungen, Ch. [Laboratoire Aimé Cotton, Université de Paris-Sud, 91405 Orsay (France)

    2015-01-22

    Ion spectroscopy, Rydberg spectroscopy and molecular dynamics are closely related subjects. Multichannel quantum defect theory is a theoretical approach which draws on this close relationship and thereby becomes a powerful tool for the study of systems consisting of a positively charged molecular ion core interacting with an electron which may be loosely bound or freely scattering.

  11. Clustering Molecular Dynamics Trajectories for Optimizing Docking Experiments

    Directory of Open Access Journals (Sweden)

    Renata De Paris

    2015-01-01

    Full Text Available Molecular dynamics simulations of protein receptors have become an attractive tool for rational drug discovery. However, the high computational cost of employing molecular dynamics trajectories in virtual screening of large repositories threats the feasibility of this task. Computational intelligence techniques have been applied in this context, with the ultimate goal of reducing the overall computational cost so the task can become feasible. Particularly, clustering algorithms have been widely used as a means to reduce the dimensionality of molecular dynamics trajectories. In this paper, we develop a novel methodology for clustering entire trajectories using structural features from the substrate-binding cavity of the receptor in order to optimize docking experiments on a cloud-based environment. The resulting partition was selected based on three clustering validity criteria, and it was further validated by analyzing the interactions between 20 ligands and a fully flexible receptor (FFR model containing a 20 ns molecular dynamics simulation trajectory. Our proposed methodology shows that taking into account features of the substrate-binding cavity as input for the k-means algorithm is a promising technique for accurately selecting ensembles of representative structures tailored to a specific ligand.

  12. A fermionic molecular dynamics technique to model nuclear matter

    International Nuclear Information System (INIS)

    Vantournhout, K.; Jachowicz, N.; Ryckebusch, J.

    2009-01-01

    Full text: At sub-nuclear densities of about 10 14 g/cm 3 , nuclear matter arranges itself in a variety of complex shapes. This can be the case in the crust of neutron stars and in core-collapse supernovae. These slab like and rod like structures, designated as nuclear pasta, have been modelled with classical molecular dynamics techniques. We present a technique, based on fermionic molecular dynamics, to model nuclear matter at sub-nuclear densities in a semi classical framework. The dynamical evolution of an antisymmetric ground state is described making the assumption of periodic boundary conditions. Adding the concepts of antisymmetry, spin and probability distributions to classical molecular dynamics, brings the dynamical description of nuclear matter to a quantum mechanical level. Applications of this model vary from investigation of macroscopic observables and the equation of state to the study of fundamental interactions on the microscopic structure of the matter. (author)

  13. Dynamical photo-induced electronic properties of molecular junctions

    Science.gov (United States)

    Beltako, K.; Michelini, F.; Cavassilas, N.; Raymond, L.

    2018-03-01

    Nanoscale molecular-electronic devices and machines are emerging as promising functional elements, naturally flexible and efficient, for next-generation technologies. A deeper understanding of carrier dynamics in molecular junctions is expected to benefit many fields of nanoelectronics and power devices. We determine time-resolved charge current flowing at the donor-acceptor interface in molecular junctions connected to metallic electrodes by means of quantum transport simulations. The current is induced by the interaction of the donor with a Gaussian-shape femtosecond laser pulse. Effects of the molecular internal coupling, metal-molecule tunneling, and light-donor coupling on photocurrent are discussed. We then define the time-resolved local density of states which is proposed as an efficient tool to describe the absorbing molecule in contact with metallic electrodes. Non-equilibrium reorganization of hybridized molecular orbitals through the light-donor interaction gives rise to two phenomena: the dynamical Rabi shift and the appearance of Floquet-like states. Such insights into the dynamical photoelectronic structure of molecules are of strong interest for ultrafast spectroscopy and open avenues toward the possibility of analyzing and controlling the internal properties of quantum nanodevices with pump-push photocurrent spectroscopy.

  14. Dynamical processes in atomic and molecular physics

    CERN Document Server

    Ogurtsov, Gennadi

    2012-01-01

    Atomic and molecular physics underlie a basis for our knowledge of fundamental processes in nature and technology and in such applications as solid state physics, chemistry and biology. In recent years, atomic and molecular physics has undergone a revolutionary change due to great achievements in computing and experimental techniques. As a result, it has become possible to obtain information both on atomic and molecular characteristics and on dynamics of atomic and molecular processes. This e-book highlights the present state of investigations in the field of atomic and molecular physics. Rece

  15. Theory and application of quantum molecular dynamics

    CERN Document Server

    Zeng Hui Zhang, John

    1999-01-01

    This book provides a detailed presentation of modern quantum theories for treating the reaction dynamics of small molecular systems. Its main focus is on the recent development of successful quantum dynamics theories and computational methods for studying the molecular reactive scattering process, with specific applications given in detail for a number of benchmark chemical reaction systems in the gas phase and the gas surface. In contrast to traditional books on collision in physics focusing on abstract theory for nonreactive scattering, this book deals with both the development and the appli

  16. Dynamics and Thermodynamics of Molecular Machines

    DEFF Research Database (Denmark)

    Golubeva, Natalia

    2014-01-01

    to their microscopic size, molecular motors are governed by principles fundamentally different from those describing the operation of man-made motors such as car engines. In this dissertation the dynamic and thermodynamic properties of molecular machines are studied using the tools of nonequilibrium statistical......Molecular machines, or molecular motors, are small biophysical devices that perform a variety of essential metabolic processes such as DNA replication, protein synthesis and intracellular transport. Typically, these machines operate by converting chemical energy into motion and mechanical work. Due...... mechanics. The first part focuses on noninteracting molecular machines described by a paradigmatic continuum model with the aim of comparing and contrasting such a description to the one offered by the widely used discrete models. Many molecular motors, for example, kinesin involved in cellular cargo...

  17. Multiple time step integrators in ab initio molecular dynamics

    International Nuclear Information System (INIS)

    Luehr, Nathan; Martínez, Todd J.; Markland, Thomas E.

    2014-01-01

    Multiple time-scale algorithms exploit the natural separation of time-scales in chemical systems to greatly accelerate the efficiency of molecular dynamics simulations. Although the utility of these methods in systems where the interactions are described by empirical potentials is now well established, their application to ab initio molecular dynamics calculations has been limited by difficulties associated with splitting the ab initio potential into fast and slowly varying components. Here we present two schemes that enable efficient time-scale separation in ab initio calculations: one based on fragment decomposition and the other on range separation of the Coulomb operator in the electronic Hamiltonian. We demonstrate for both water clusters and a solvated hydroxide ion that multiple time-scale molecular dynamics allows for outer time steps of 2.5 fs, which are as large as those obtained when such schemes are applied to empirical potentials, while still allowing for bonds to be broken and reformed throughout the dynamics. This permits computational speedups of up to 4.4x, compared to standard Born-Oppenheimer ab initio molecular dynamics with a 0.5 fs time step, while maintaining the same energy conservation and accuracy

  18. A framework for scalable parameter estimation of gene circuit models using structural information.

    Science.gov (United States)

    Kuwahara, Hiroyuki; Fan, Ming; Wang, Suojin; Gao, Xin

    2013-07-01

    Systematic and scalable parameter estimation is a key to construct complex gene regulatory models and to ultimately facilitate an integrative systems biology approach to quantitatively understand the molecular mechanisms underpinning gene regulation. Here, we report a novel framework for efficient and scalable parameter estimation that focuses specifically on modeling of gene circuits. Exploiting the structure commonly found in gene circuit models, this framework decomposes a system of coupled rate equations into individual ones and efficiently integrates them separately to reconstruct the mean time evolution of the gene products. The accuracy of the parameter estimates is refined by iteratively increasing the accuracy of numerical integration using the model structure. As a case study, we applied our framework to four gene circuit models with complex dynamics based on three synthetic datasets and one time series microarray data set. We compared our framework to three state-of-the-art parameter estimation methods and found that our approach consistently generated higher quality parameter solutions efficiently. Although many general-purpose parameter estimation methods have been applied for modeling of gene circuits, our results suggest that the use of more tailored approaches to use domain-specific information may be a key to reverse engineering of complex biological systems. http://sfb.kaust.edu.sa/Pages/Software.aspx. Supplementary data are available at Bioinformatics online.

  19. Dynamic signature of molecular association in methanol

    International Nuclear Information System (INIS)

    Bertrand, C. E.; Copley, J. R. D.; Faraone, A.; Self, J. L.

    2016-01-01

    Quasielastic neutron scattering measurements and molecular dynamics simulations were combined to investigate the collective dynamics of deuterated methanol, CD 3 OD. In the experimentally determined dynamic structure factor, a slow, non-Fickian mode was observed in addition to the standard density-fluctuation heat mode. The simulation results indicate that the slow dynamical process originates from the hydrogen bonding of methanol molecules. The qualitative behavior of this mode is similar to the previously observed α-relaxation in supercooled water [M. C. Bellissent-Funel et al., Phys. Rev. Lett. 85, 3644 (2000)] which also originates from the formation and dissolution of hydrogen-bonded associates (supramolecular clusters). In methanol, however, this mode is distinguishable well above the freezing transition. This finding indicates that an emergent slow mode is not unique to supercooled water, but may instead be a general feature of hydrogen-bonding liquids and associating molecular liquids.

  20. Molecular dynamics for fermions

    International Nuclear Information System (INIS)

    Feldmeier, H.; Schnack, J.

    2000-02-01

    The time-dependent variational principle for many-body trial states is used to discuss the relation between the approaches of different molecular dynamics models to describe indistinguishable fermions. Early attempts to include effects of the Pauli principle by means of nonlocal potentials as well as more recent models which work with antisymmetrized many-body states are reviewed under these premises. (orig.)

  1. Pattern recognition in molecular dynamics. [FORTRAN

    Energy Technology Data Exchange (ETDEWEB)

    Zurek, W H; Schieve, W C [Texas Univ., Austin (USA)

    1977-07-01

    An algorithm for the recognition of the formation of bound molecular states in the computer simulation of a dilute gas is presented. Applications to various related problems in physics and chemistry are pointed out. Data structure and decision processes are described. Performance of the FORTRAN program based on the algorithm in cooperation with the molecular dynamics program is described and the results are presented.

  2. ATLAS Grid Data Processing: system evolution and scalability

    CERN Document Server

    Golubkov, D; The ATLAS collaboration; Klimentov, A; Minaenko, A; Nevski, P; Vaniachine, A; Walker, R

    2012-01-01

    The production system for Grid Data Processing handles petascale ATLAS data reprocessing and Monte Carlo activities. The production system empowered further data processing steps on the Grid performed by dozens of ATLAS physics groups with coordinated access to computing resources worldwide, including additional resources sponsored by regional facilities. The system provides knowledge management of configuration parameters for massive data processing tasks, reproducibility of results, scalable database access, orchestrated workflow and performance monitoring, dynamic workload sharing, automated fault tolerance and petascale data integrity control. The system evolves to accommodate a growing number of users and new requirements from our contacts in ATLAS main areas: Trigger, Physics, Data Preparation and Software & Computing. To assure scalability, the next generation production system architecture development is in progress. We report on scaling up the production system for a growing number of users provi...

  3. Scalable Nanomanufacturing—A Review

    Directory of Open Access Journals (Sweden)

    Khershed Cooper

    2017-01-01

    Full Text Available This article describes the field of scalable nanomanufacturing, its importance and need, its research activities and achievements. The National Science Foundation is taking a leading role in fostering basic research in scalable nanomanufacturing (SNM. From this effort several novel nanomanufacturing approaches have been proposed, studied and demonstrated, including scalable nanopatterning. This paper will discuss SNM research areas in materials, processes and applications, scale-up methods with project examples, and manufacturing challenges that need to be addressed to move nanotechnology discoveries closer to the marketplace.

  4. Improving the Efficiency of Free Energy Calculations in the Amber Molecular Dynamics Package.

    Science.gov (United States)

    Kaus, Joseph W; Pierce, Levi T; Walker, Ross C; McCammont, J Andrew

    2013-09-10

    Alchemical transformations are widely used methods to calculate free energies. Amber has traditionally included support for alchemical transformations as part of the sander molecular dynamics (MD) engine. Here we describe the implementation of a more efficient approach to alchemical transformations in the Amber MD package. Specifically we have implemented this new approach within the more computational efficient and scalable pmemd MD engine that is included with the Amber MD package. The majority of the gain in efficiency comes from the improved design of the calculation, which includes better parallel scaling and reduction in the calculation of redundant terms. This new implementation is able to reproduce results from equivalent simulations run with the existing functionality, but at 2.5 times greater computational efficiency. This new implementation is also able to run softcore simulations at the λ end states making direct calculation of free energies more accurate, compared to the extrapolation required in the existing implementation. The updated alchemical transformation functionality will be included in the next major release of Amber (scheduled for release in Q1 2014) and will be available at http://ambermd.org, under the Amber license.

  5. Molecular sieving through a graphene nanopore: non-equilibrium molecular dynamics simulation

    Institute of Scientific and Technical Information of China (English)

    Chengzhen Sun; Bofeng Bai

    2017-01-01

    Two-dimensional graphene nanopores have shown great promise as ultra-permeable molecular sieves based on their size-sieving effects.We design a nitrogen/hydrogen modified graphene nanopore and conduct a transient non-equilibrium molecular dynamics simulation on its molecular sieving effects.The distinct time-varying molecular crossing numbers show that this special nanopore can efficiently sieve CO2 and H2S molecules from CH4 molecules with high selectivity.By analyzing the molecular structure and pore functionalization-related molecular orientation and permeable zone in the nanopore,density distribution in the molecular adsorption layer on the graphene surface,as well as other features,the molecular sieving mechanisms of graphene nanopores are revealed.Finally,several implications on the design of highly-efficient graphene nanopores,especially for determining the porosity and chemical functionalization,as gas separation membranes are summarized based on the identified phenomena and mechanisms.

  6. Classical and quantum molecular dynamics in NMR spectra

    CERN Document Server

    Szymański, Sławomir

    2018-01-01

    The book provides a detailed account of how condensed-phase molecular dynamics are reflected in the line shapes of NMR spectra. The theories establishing connections between random, time-dependent molecular processes and lineshape effects are exposed in depth. Special emphasis is placed on the theoretical aspects, involving in particular intermolecular processes in solution, and molecular symmetry issues. The Liouville super-operator formalism is briefly introduced and used wherever it is beneficial for the transparency of presentation. The proposed formal descriptions of the discussed problems are sufficiently detailed to be implemented on a computer. Practical applications of the theory in solid- and liquid-phase studies are illustrated with appropriate experimental examples, exposing the potential of the lineshape method in elucidating molecular dynamics NMR-observable molecular phenomena where quantization of the spatial nuclear degrees of freedom is crucial are addressed in the last part of the book. As ...

  7. Multiscale equation-free algorithms for molecular dynamics

    Science.gov (United States)

    Abi Mansour, Andrew

    Molecular dynamics is a physics-based computational tool that has been widely employed to study the dynamics and structure of macromolecules and their assemblies at the atomic scale. However, the efficiency of molecular dynamics simulation is limited because of the broad spectrum of timescales involved. To overcome this limitation, an equation-free algorithm is presented for simulating these systems using a multiscale model cast in terms of atomistic and coarse-grained variables. Both variables are evolved in time in such a way that the cross-talk between short and long scales is preserved. In this way, the coarse-grained variables guide the evolution of the atom-resolved states, while the latter provide the Newtonian physics for the former. While the atomistic variables are evolved using short molecular dynamics runs, time advancement at the coarse-grained level is achieved with a scheme that uses information from past and future states of the system while accounting for both the stochastic and deterministic features of the coarse-grained dynamics. To complete the multiscale cycle, an atom-resolved state consistent with the updated coarse-grained variables is recovered using algorithms from mathematical optimization. This multiscale paradigm is extended to nanofluidics using concepts from hydrodynamics, and it is demonstrated for macromolecular and nanofluidic systems. A toolkit is developed for prototyping these algorithms, which are then implemented within the GROMACS simulation package and released as an open source multiscale simulator.

  8. Molecular stopwatches, cogwheels and ``spinflakes'': studying the dynamics of molecular superrotors

    Science.gov (United States)

    Korobenko, Aleksey; Milner, Alexander; Hepburn, John; Milner, Valery

    2015-05-01

    Using the technique of an optical centrifuge, we excite diatomic molecules to ultrafast synchronous rotation. Femtosecond velocity-map imaging allows us to visualize and study the coherent dynamics of molecular superrotors under field free conditions and in external magnetic field. We demonstrate that when the created rotational wave packet is narrow, its free evolution is nondispersing and follows the motion of a classically rotating dumbbell or a hand of the smallest natural stopwatch. For wider rotational distributions, we observe the breakdown of classical rotation, when a dumbbell shape changes to that of a ``quantum cogwheel'' - a molecular state simultaneously aligned along multiple direction. Our measurements in external magnetic field reveal other peculiar aspects of the rich dynamics of molecular superrotors. The rotation of a non-magnetic molecule interacts with the applied field only weakly, giving rise to slow precession of the molecular angular momentum around the field direction. In contrast, the electronic spin of a paramagnetic superrotor mediates this interaction, causing the initial disk-like angular distribution to split into several spatial components, each precessing with its own frequency determined by the spin projection.

  9. High-Performance Modeling of Carbon Dioxide Sequestration by Coupling Reservoir Simulation and Molecular Dynamics

    KAUST Repository

    Bao, Kai

    2015-10-26

    The present work describes a parallel computational framework for carbon dioxide (CO2) sequestration simulation by coupling reservoir simulation and molecular dynamics (MD) on massively parallel high-performance-computing (HPC) systems. In this framework, a parallel reservoir simulator, reservoir-simulation toolbox (RST), solves the flow and transport equations that describe the subsurface flow behavior, whereas the MD simulations are performed to provide the required physical parameters. Technologies from several different fields are used to make this novel coupled system work efficiently. One of the major applications of the framework is the modeling of large-scale CO2 sequestration for long-term storage in subsurface geological formations, such as depleted oil and gas reservoirs and deep saline aquifers, which has been proposed as one of the few attractive and practical solutions to reduce CO2 emissions and address the global-warming threat. Fine grids and accurate prediction of the properties of fluid mixtures under geological conditions are essential for accurate simulations. In this work, CO2 sequestration is presented as a first example for coupling reservoir simulation and MD, although the framework can be extended naturally to the full multiphase multicomponent compositional flow simulation to handle more complicated physical processes in the future. Accuracy and scalability analysis are performed on an IBM BlueGene/P and on an IBM BlueGene/Q, the latest IBM supercomputer. Results show good accuracy of our MD simulations compared with published data, and good scalability is observed with the massively parallel HPC systems. The performance and capacity of the proposed framework are well-demonstrated with several experiments with hundreds of millions to one billion cells. To the best of our knowledge, the present work represents the first attempt to couple reservoir simulation and molecular simulation for large-scale modeling. Because of the complexity of

  10. Molecular quantum dynamics. From theory to applications

    International Nuclear Information System (INIS)

    Gatti, Fabien

    2014-01-01

    An educational and accessible introduction to the field of molecular quantum dynamics. Illustrates the importance of the topic for broad areas of science: from astrophysics and the physics of the atmosphere, over elementary processes in chemistry, to biological processes. Presents chosen examples of striking applications, highlighting success stories, summarized by the internationally renowned experts. Including a foreword by Lorenz Cederbaum (University Heidelberg, Germany). This book focuses on current applications of molecular quantum dynamics. Examples from all main subjects in the field, presented by the internationally renowned experts, illustrate the importance of the domain. Recent success in helping to understand experimental observations in fields like heterogeneous catalysis, photochemistry, reactive scattering, optical spectroscopy, or femto- and attosecond chemistry and spectroscopy underline that nuclear quantum mechanical effects affect many areas of chemical and physical research. In contrast to standard quantum chemistry calculations, where the nuclei are treated classically, molecular quantum dynamics can cover quantum mechanical effects in their motion. Many examples, ranging from fundamental to applied problems, are known today that are impacted by nuclear quantum mechanical effects, including phenomena like tunneling, zero point energy effects, or non-adiabatic transitions. Being important to correctly understand many observations in chemical, organic and biological systems, or for the understanding of molecular spectroscopy, the range of applications covered in this book comprises broad areas of science: from astrophysics and the physics and chemistry of the atmosphere, over elementary processes in chemistry, to biological processes (such as the first steps of photosynthesis or vision). Nevertheless, many researchers refrain from entering this domain. The book ''Molecular Quantum Dynamics'' offers them an accessible introduction. Although the

  11. Molecular quantum dynamics. From theory to applications

    Energy Technology Data Exchange (ETDEWEB)

    Gatti, Fabien (ed.) [Montpellier 2 Univ. (France). Inst. Charles Gerhardt - CNRS 5253

    2014-09-01

    An educational and accessible introduction to the field of molecular quantum dynamics. Illustrates the importance of the topic for broad areas of science: from astrophysics and the physics of the atmosphere, over elementary processes in chemistry, to biological processes. Presents chosen examples of striking applications, highlighting success stories, summarized by the internationally renowned experts. Including a foreword by Lorenz Cederbaum (University Heidelberg, Germany). This book focuses on current applications of molecular quantum dynamics. Examples from all main subjects in the field, presented by the internationally renowned experts, illustrate the importance of the domain. Recent success in helping to understand experimental observations in fields like heterogeneous catalysis, photochemistry, reactive scattering, optical spectroscopy, or femto- and attosecond chemistry and spectroscopy underline that nuclear quantum mechanical effects affect many areas of chemical and physical research. In contrast to standard quantum chemistry calculations, where the nuclei are treated classically, molecular quantum dynamics can cover quantum mechanical effects in their motion. Many examples, ranging from fundamental to applied problems, are known today that are impacted by nuclear quantum mechanical effects, including phenomena like tunneling, zero point energy effects, or non-adiabatic transitions. Being important to correctly understand many observations in chemical, organic and biological systems, or for the understanding of molecular spectroscopy, the range of applications covered in this book comprises broad areas of science: from astrophysics and the physics and chemistry of the atmosphere, over elementary processes in chemistry, to biological processes (such as the first steps of photosynthesis or vision). Nevertheless, many researchers refrain from entering this domain. The book ''Molecular Quantum Dynamics'' offers them an accessible

  12. Excited-state molecular photoionization dynamics

    International Nuclear Information System (INIS)

    Pratt, S.T.

    1995-01-01

    This review presents a survey of work using resonance-enhanced multiphoton ionization and double-resonance techniques to study excited-state photoionization dynamics in molecules. These techniques routinely provide detail and precision that are difficult to achieve in single-photon ionization from the ground state. The review not only emphasizes new aspects of photoionization revealed in the excited-state experiments but also shows how the excited-state techniques can provide textbook illustrations of some fundamental mechanisms in molecular photoionization dynamics. Most of the examples are confined to diatomic molecules. (author)

  13. Symmetry of quantum molecular dynamics

    International Nuclear Information System (INIS)

    Burenin, A.V.

    2002-01-01

    The paper reviews the current state-of-art in describing quantum molecular dynamics based on symmetry principles alone. This qualitative approach is of particular interest as the only method currently available for a broad and topical class of problems in the internal dynamics of molecules. Besides, a molecule is a physical system whose collective internal motions are geometrically structured, and its perturbation theory description requires a symmetry analysis of this structure. The nature of the geometrical symmetry groups crucial for the closed formulation of the qualitative approach is discussed [ru

  14. Molecular dynamics modeling of polymer flammability

    International Nuclear Information System (INIS)

    Nyden, M.R.; Brown, J.E.; Lomakin, S.M.

    1992-01-01

    Molecular dynamic simulations were used to identify factors which promote char formation during the thermal degradation of polymers. Computer movies based on these simulations, indicate that cross-linked model polymers tend to undergo further cross-linking when burned, eventually forming a high molecular weight, thermally stable char. This paper reports that the prediction was confirmed by char yield measurements made on γ and e - -irradiated polyethylene and chemically cross-linked poly(methyl methacrylate)

  15. Electron-nuclear dynamics of molecular systems

    International Nuclear Information System (INIS)

    Diz, A.; Oehrn, Y.

    1994-01-01

    The content of an ab initio time-dependent theory of quantum molecular dynamics of electrons and atomic nuclei is presented. Employing the time-dependent variational principle and a family of approximate state vectors yields a set of dynamical equations approximating the time-dependent Schroedinger equation. These equations govern the time evolution of the relevant state vector parameters as molecular orbital coefficients, nuclear positions, and momenta. This approach does not impose the Born-Oppenheimer approximation, does not use potential energy surfaces, and takes into account electron-nuclear coupling. Basic conservation laws are fully obeyed. The simplest model of the theory employs a single determinantal state for the electrons and classical nuclei and is implemented in the computer code ENDyne. Results from this ab-initio theory are reported for ion-atom and ion-molecule collisions

  16. Thermostating extended Lagrangian Born-Oppenheimer molecular dynamics.

    Science.gov (United States)

    Martínez, Enrique; Cawkwell, Marc J; Voter, Arthur F; Niklasson, Anders M N

    2015-04-21

    Extended Lagrangian Born-Oppenheimer molecular dynamics is developed and analyzed for applications in canonical (NVT) simulations. Three different approaches are considered: the Nosé and Andersen thermostats and Langevin dynamics. We have tested the temperature distribution under different conditions of self-consistent field (SCF) convergence and time step and compared the results to analytical predictions. We find that the simulations based on the extended Lagrangian Born-Oppenheimer framework provide accurate canonical distributions even under approximate SCF convergence, often requiring only a single diagonalization per time step, whereas regular Born-Oppenheimer formulations exhibit unphysical fluctuations unless a sufficiently high degree of convergence is reached at each time step. The thermostated extended Lagrangian framework thus offers an accurate approach to sample processes in the canonical ensemble at a fraction of the computational cost of regular Born-Oppenheimer molecular dynamics simulations.

  17. Dynamics of molecular superrotors in an external magnetic field

    Science.gov (United States)

    Korobenko, Aleksey; Milner, Valery

    2015-08-01

    We excite diatomic oxygen and nitrogen to high rotational states with an optical centrifuge and study their dynamics in an external magnetic field. Ion imaging is employed to directly visualize, and follow in time, the rotation plane of the molecular superrotors. The two different mechanisms of interaction between the magnetic field and the molecular angular momentum in paramagnetic oxygen and non-magnetic nitrogen lead to qualitatively different behaviour. In nitrogen, we observe the precession of the molecular angular momentum around the field vector. In oxygen, strong spin-rotation coupling results in faster and richer dynamics, encompassing the splitting of the rotation plane into three separate components. As the centrifuged molecules evolve with no significant dispersion of the molecular wave function, the observed magnetic interaction presents an efficient mechanism for controlling the plane of molecular rotation.

  18. Femtochemistry and femtobiology ultrafast dynamics in molecular science

    CERN Document Server

    Douhal, Abderrazzak

    2002-01-01

    This book contains important contributions from top international scientists on the-state-of-the-art of femtochemistry and femtobiology at the beginning of the new millennium. It consists of reviews and papers on ultrafast dynamics in molecular science.The coverage of topics highlights several important features of molecular science from the viewpoint of structure (space domain) and dynamics (time domain). First of all, the book presents the latest developments, such as experimental techniques for understanding ultrafast processes in gas, condensed and complex systems, including biological mol

  19. Molecular dynamics simulation of ribosome jam

    KAUST Repository

    Matsumoto, Shigenori; Takagi, Fumiko; Shimada, Takashi; Ito, Nobuyasu

    2011-01-01

    We propose a coarse-grained molecular dynamics model of ribosome molecules to study the dependence of translation process on environmental parameters. We found the model exhibits traffic jam property, which is consistent with an ASEP model. We

  20. Non-periodic molecular dynamics simulations of coarse grained lipid bilayer in water

    DEFF Research Database (Denmark)

    Kotsalis, E. M.; Hanasaki, I.; Walther, Jens Honore

    2010-01-01

    We present a multiscale algorithm that couples coarse grained molecular dynamics (CGMD) with continuum solver. The coupling requires the imposition of non-periodic boundary conditions on the coarse grained Molecular Dynamics which, when not properly enforced, may result in spurious fluctuations o...... in simulating more complex systems by performing a non-periodic Molecular Dynamics simulation of a DPPC lipid in liquid coarse grained water.......We present a multiscale algorithm that couples coarse grained molecular dynamics (CGMD) with continuum solver. The coupling requires the imposition of non-periodic boundary conditions on the coarse grained Molecular Dynamics which, when not properly enforced, may result in spurious fluctuations...... of the material properties of the system represented by CGMD. In this paper we extend a control algorithm originally developed for atomistic simulations [3], to conduct simulations involving coarse grained water molecules without periodic boundary conditions. We demonstrate the applicability of our method...

  1. Scalable fast multipole accelerated vortex methods

    KAUST Repository

    Hu, Qi

    2014-05-01

    The fast multipole method (FMM) is often used to accelerate the calculation of particle interactions in particle-based methods to simulate incompressible flows. To evaluate the most time-consuming kernels - the Biot-Savart equation and stretching term of the vorticity equation, we mathematically reformulated it so that only two Laplace scalar potentials are used instead of six. This automatically ensuring divergence-free far-field computation. Based on this formulation, we developed a new FMM-based vortex method on heterogeneous architectures, which distributed the work between multicore CPUs and GPUs to best utilize the hardware resources and achieve excellent scalability. The algorithm uses new data structures which can dynamically manage inter-node communication and load balance efficiently, with only a small parallel construction overhead. This algorithm can scale to large-sized clusters showing both strong and weak scalability. Careful error and timing trade-off analysis are also performed for the cutoff functions induced by the vortex particle method. Our implementation can perform one time step of the velocity+stretching calculation for one billion particles on 32 nodes in 55.9 seconds, which yields 49.12 Tflop/s.

  2. Dynamics of molecular superrotors in an external magnetic field

    International Nuclear Information System (INIS)

    Korobenko, Aleksey; Milner, Valery

    2015-01-01

    We excite diatomic oxygen and nitrogen to high rotational states with an optical centrifuge and study their dynamics in an external magnetic field. Ion imaging is employed to directly visualize, and follow in time, the rotation plane of the molecular superrotors. The two different mechanisms of interaction between the magnetic field and the molecular angular momentum in paramagnetic oxygen and non-magnetic nitrogen lead to qualitatively different behaviour. In nitrogen, we observe the precession of the molecular angular momentum around the field vector. In oxygen, strong spin–rotation coupling results in faster and richer dynamics, encompassing the splitting of the rotation plane into three separate components. As the centrifuged molecules evolve with no significant dispersion of the molecular wave function, the observed magnetic interaction presents an efficient mechanism for controlling the plane of molecular rotation. (paper)

  3. The Development and Comparison of Molecular Dynamics Simulation and Monte Carlo Simulation

    Science.gov (United States)

    Chen, Jundong

    2018-03-01

    Molecular dynamics is an integrated technology that combines physics, mathematics and chemistry. Molecular dynamics method is a computer simulation experimental method, which is a powerful tool for studying condensed matter system. This technique not only can get the trajectory of the atom, but can also observe the microscopic details of the atomic motion. By studying the numerical integration algorithm in molecular dynamics simulation, we can not only analyze the microstructure, the motion of particles and the image of macroscopic relationship between them and the material, but can also study the relationship between the interaction and the macroscopic properties more conveniently. The Monte Carlo Simulation, similar to the molecular dynamics, is a tool for studying the micro-molecular and particle nature. In this paper, the theoretical background of computer numerical simulation is introduced, and the specific methods of numerical integration are summarized, including Verlet method, Leap-frog method and Velocity Verlet method. At the same time, the method and principle of Monte Carlo Simulation are introduced. Finally, similarities and differences of Monte Carlo Simulation and the molecular dynamics simulation are discussed.

  4. Kinetics from Replica Exchange Molecular Dynamics Simulations.

    Science.gov (United States)

    Stelzl, Lukas S; Hummer, Gerhard

    2017-08-08

    Transitions between metastable states govern many fundamental processes in physics, chemistry and biology, from nucleation events in phase transitions to the folding of proteins. The free energy surfaces underlying these processes can be obtained from simulations using enhanced sampling methods. However, their altered dynamics makes kinetic and mechanistic information difficult or impossible to extract. Here, we show that, with replica exchange molecular dynamics (REMD), one can not only sample equilibrium properties but also extract kinetic information. For systems that strictly obey first-order kinetics, the procedure to extract rates is rigorous. For actual molecular systems whose long-time dynamics are captured by kinetic rate models, accurate rate coefficients can be determined from the statistics of the transitions between the metastable states at each replica temperature. We demonstrate the practical applicability of the procedure by constructing master equation (Markov state) models of peptide and RNA folding from REMD simulations.

  5. Integrating atomistic molecular dynamics simulations, experiments, and network analysis to study protein dynamics

    DEFF Research Database (Denmark)

    Papaleo, Elena

    2015-01-01

    that we observe and the functional properties of these important cellular machines. To make progresses in this direction, we need to improve the physical models used to describe proteins and solvent in molecular dynamics, as well as to strengthen the integration of experiments and simulations to overcome...... with the possibility to validate simulation methods and physical models against a broad range of experimental observables. On the other side, it also allows a complementary and comprehensive view on protein structure and dynamics. What is needed now is a better understanding of the link between the dynamic properties...... simulations with attention to the effects that can be propagated over long distances and are often associated to important biological functions. In this context, approaches inspired by network analysis can make an important contribution to the analysis of molecular dynamics simulations....

  6. AceCloud: Molecular Dynamics Simulations in the Cloud.

    Science.gov (United States)

    Harvey, M J; De Fabritiis, G

    2015-05-26

    We present AceCloud, an on-demand service for molecular dynamics simulations. AceCloud is designed to facilitate the secure execution of large ensembles of simulations on an external cloud computing service (currently Amazon Web Services). The AceCloud client, integrated into the ACEMD molecular dynamics package, provides an easy-to-use interface that abstracts all aspects of interaction with the cloud services. This gives the user the experience that all simulations are running on their local machine, minimizing the learning curve typically associated with the transition to using high performance computing services.

  7. Molecular dynamics simulations of RNA motifs

    Czech Academy of Sciences Publication Activity Database

    Csaszar, K.; Špačková, Naďa; Šponer, Jiří; Leontis, N. B.

    2002-01-01

    Roč. 223, - (2002), s. 154 ISSN 0065-7727. [Annual Meeting of the American Chemistry Society /223./. 07.04.2002-11.04.2002, Orlando ] Institutional research plan: CEZ:AV0Z5004920 Keywords : molecular dynamics * RNA * hydration Subject RIV: BO - Biophysics

  8. Monte Carlo-molecular dynamics simulations for two-dimensional magnets

    International Nuclear Information System (INIS)

    Kawabata, C.; takeuchi, M.; Bishop, A.R.

    1985-01-01

    A combined Monte Carlo-molecular dynamics simulation technique is used to study the dynamic structure factor on a square lattice for isotropic Heisenberg and planar classical ferromagnetic spin Hamiltonians

  9. Molecular dynamics and Monte Carlo calculations in statistical mechanics

    International Nuclear Information System (INIS)

    Wood, W.W.; Erpenbeck, J.J.

    1976-01-01

    Monte Carlo and molecular dynamics calculations on statistical mechanical systems is reviewed giving some of the more significant recent developments. It is noted that the term molecular dynamics refers to the time-averaging technique for hard-core and square-well interactions and for continuous force-law interactions. Ergodic questions, methodology, quantum mechanical, Lorentz, and one-dimensional, hard-core, and square and triangular-well systems, short-range soft potentials, and other systems are included. 268 references

  10. Numeric Analysis for Relationship-Aware Scalable Streaming Scheme

    Directory of Open Access Journals (Sweden)

    Heung Ki Lee

    2014-01-01

    Full Text Available Frequent packet loss of media data is a critical problem that degrades the quality of streaming services over mobile networks. Packet loss invalidates frames containing lost packets and other related frames at the same time. Indirect loss caused by losing packets decreases the quality of streaming. A scalable streaming service can decrease the amount of dropped multimedia resulting from a single packet loss. Content providers typically divide one large media stream into several layers through a scalable streaming service and then provide each scalable layer to the user depending on the mobile network. Also, a scalable streaming service makes it possible to decode partial multimedia data depending on the relationship between frames and layers. Therefore, a scalable streaming service provides a way to decrease the wasted multimedia data when one packet is lost. However, the hierarchical structure between frames and layers of scalable streams determines the service quality of the scalable streaming service. Even if whole packets of layers are transmitted successfully, they cannot be decoded as a result of the absence of reference frames and layers. Therefore, the complicated relationship between frames and layers in a scalable stream increases the volume of abandoned layers. For providing a high-quality scalable streaming service, we choose a proper relationship between scalable layers as well as the amount of transmitted multimedia data depending on the network situation. We prove that a simple scalable scheme outperforms a complicated scheme in an error-prone network. We suggest an adaptive set-top box (AdaptiveSTB to lower the dependency between scalable layers in a scalable stream. Also, we provide a numerical model to obtain the indirect loss of multimedia data and apply it to various multimedia streams. Our AdaptiveSTB enhances the quality of a scalable streaming service by removing indirect loss.

  11. Molecular Dynamics Simulations of Poly(dimethylsiloxane) Properties

    Czech Academy of Sciences Publication Activity Database

    Fojtíková, J.; Kalvoda, L.; Sedlák, Petr

    2015-01-01

    Roč. 128, č. 4 (2015), s. 637-639 ISSN 0587-4246 R&D Projects: GA ČR GB14-36566G Institutional support: RVO:61388998 Keywords : molecular dynamics * poly(dimethylsiloxane) * dissipative particle dynamics Subject RIV: BM - Solid Matter Physics ; Magnetism Impact factor: 0.525, year: 2015 http://przyrbwn.icm.edu.pl/APP/PDF/128/a128z4p40.pdf

  12. Nanotribology investigations with classical molecular dynamics

    NARCIS (Netherlands)

    Solhjoo, Soheil

    2017-01-01

    This thesis presents a number of nanotribological problems investigated by means of classical molecular dynamics (MD) simulations, within the context of the applicability of continuum mechanics contact theories at the atomic scale. Along these lines, three different themes can be recognized herein:

  13. Scalable coherent interface

    International Nuclear Information System (INIS)

    Alnaes, K.; Kristiansen, E.H.; Gustavson, D.B.; James, D.V.

    1990-01-01

    The Scalable Coherent Interface (IEEE P1596) is establishing an interface standard for very high performance multiprocessors, supporting a cache-coherent-memory model scalable to systems with up to 64K nodes. This Scalable Coherent Interface (SCI) will supply a peak bandwidth per node of 1 GigaByte/second. The SCI standard should facilitate assembly of processor, memory, I/O and bus bridge cards from multiple vendors into massively parallel systems with throughput far above what is possible today. The SCI standard encompasses two levels of interface, a physical level and a logical level. The physical level specifies electrical, mechanical and thermal characteristics of connectors and cards that meet the standard. The logical level describes the address space, data transfer protocols, cache coherence mechanisms, synchronization primitives and error recovery. In this paper we address logical level issues such as packet formats, packet transmission, transaction handshake, flow control, and cache coherence. 11 refs., 10 figs

  14. Gas-Phase Molecular Dynamics: Theoretical Studies in Spectroscopy and Chemical Dynamics

    Energy Technology Data Exchange (ETDEWEB)

    Yu, H.G.; Muckerman, J.T.

    2010-06-01

    The goal of this program is the development and application of computational methods for studying chemical reaction dynamics and molecular spectroscopy in the gas phase. We are interested in developing rigorous quantum dynamics algorithms for small polyatomic systems and in implementing approximate approaches for complex ones. Particular focus is on the dynamics and kinetics of chemical reactions and on the rovibrational spectra of species involved in combustion processes. This research also explores the potential energy surfaces of these systems of interest using state-of-the-art quantum chemistry methods.

  15. A Force Balanced Fragmentation Method for ab Initio Molecular Dynamic Simulation of Protein

    Directory of Open Access Journals (Sweden)

    Mingyuan Xu

    2018-05-01

    Full Text Available A force balanced generalized molecular fractionation with conjugate caps (FB-GMFCC method is proposed for ab initio molecular dynamic simulation of proteins. In this approach, the energy of the protein is computed by a linear combination of the QM energies of individual residues and molecular fragments that account for the two-body interaction of hydrogen bond between backbone peptides. The atomic forces on the caped H atoms were corrected to conserve the total force of the protein. Using this approach, ab initio molecular dynamic simulation of an Ace-(ALA9-NME linear peptide showed the conservation of the total energy of the system throughout the simulation. Further a more robust 110 ps ab initio molecular dynamic simulation was performed for a protein with 56 residues and 862 atoms in explicit water. Compared with the classical force field, the ab initio molecular dynamic simulations gave better description of the geometry of peptide bonds. Although further development is still needed, the current approach is highly efficient, trivially parallel, and can be applied to ab initio molecular dynamic simulation study of large proteins.

  16. Energy conserving, linear scaling Born-Oppenheimer molecular dynamics.

    Science.gov (United States)

    Cawkwell, M J; Niklasson, Anders M N

    2012-10-07

    Born-Oppenheimer molecular dynamics simulations with long-term conservation of the total energy and a computational cost that scales linearly with system size have been obtained simultaneously. Linear scaling with a low pre-factor is achieved using density matrix purification with sparse matrix algebra and a numerical threshold on matrix elements. The extended Lagrangian Born-Oppenheimer molecular dynamics formalism [A. M. N. Niklasson, Phys. Rev. Lett. 100, 123004 (2008)] yields microcanonical trajectories with the approximate forces obtained from the linear scaling method that exhibit no systematic drift over hundreds of picoseconds and which are indistinguishable from trajectories computed using exact forces.

  17. MicROS-drt: supporting real-time and scalable data distribution in distributed robotic systems.

    Science.gov (United States)

    Ding, Bo; Wang, Huaimin; Fan, Zedong; Zhang, Pengfei; Liu, Hui

    A primary requirement in distributed robotic software systems is the dissemination of data to all interested collaborative entities in a timely and scalable manner. However, providing such a service in a highly dynamic and resource-limited robotic environment is a challenging task, and existing robot software infrastructure has limitations in this aspect. This paper presents a novel robot software infrastructure, micROS-drt, which supports real-time and scalable data distribution. The solution is based on a loosely coupled data publish-subscribe model with the ability to support various time-related constraints. And to realize this model, a mature data distribution standard, the data distribution service for real-time systems (DDS), is adopted as the foundation of the transport layer of this software infrastructure. By elaborately adapting and encapsulating the capability of the underlying DDS middleware, micROS-drt can meet the requirement of real-time and scalable data distribution in distributed robotic systems. Evaluation results in terms of scalability, latency jitter and transport priority as well as the experiment on real robots validate the effectiveness of this work.

  18. Scalable photoreactor for hydrogen production

    KAUST Repository

    Takanabe, Kazuhiro; Shinagawa, Tatsuya

    2017-01-01

    Provided herein are scalable photoreactors that can include a membrane-free water- splitting electrolyzer and systems that can include a plurality of membrane-free water- splitting electrolyzers. Also provided herein are methods of using the scalable photoreactors provided herein.

  19. Scalable photoreactor for hydrogen production

    KAUST Repository

    Takanabe, Kazuhiro

    2017-04-06

    Provided herein are scalable photoreactors that can include a membrane-free water- splitting electrolyzer and systems that can include a plurality of membrane-free water- splitting electrolyzers. Also provided herein are methods of using the scalable photoreactors provided herein.

  20. Resource-aware complexity scalability for mobile MPEG encoding

    NARCIS (Netherlands)

    Mietens, S.O.; With, de P.H.N.; Hentschel, C.; Panchanatan, S.; Vasudev, B.

    2004-01-01

    Complexity scalability attempts to scale the required resources of an algorithm with the chose quality settings, in order to broaden the application range. In this paper, we present complexity-scalable MPEG encoding of which the core processing modules are modified for scalability. Scalability is

  1. Modeling ramp compression experiments using large-scale molecular dynamics simulation.

    Energy Technology Data Exchange (ETDEWEB)

    Mattsson, Thomas Kjell Rene; Desjarlais, Michael Paul; Grest, Gary Stephen; Templeton, Jeremy Alan; Thompson, Aidan Patrick; Jones, Reese E.; Zimmerman, Jonathan A.; Baskes, Michael I. (University of California, San Diego); Winey, J. Michael (Washington State University); Gupta, Yogendra Mohan (Washington State University); Lane, J. Matthew D.; Ditmire, Todd (University of Texas at Austin); Quevedo, Hernan J. (University of Texas at Austin)

    2011-10-01

    Molecular dynamics simulation (MD) is an invaluable tool for studying problems sensitive to atomscale physics such as structural transitions, discontinuous interfaces, non-equilibrium dynamics, and elastic-plastic deformation. In order to apply this method to modeling of ramp-compression experiments, several challenges must be overcome: accuracy of interatomic potentials, length- and time-scales, and extraction of continuum quantities. We have completed a 3 year LDRD project with the goal of developing molecular dynamics simulation capabilities for modeling the response of materials to ramp compression. The techniques we have developed fall in to three categories (i) molecular dynamics methods (ii) interatomic potentials (iii) calculation of continuum variables. Highlights include the development of an accurate interatomic potential describing shock-melting of Beryllium, a scaling technique for modeling slow ramp compression experiments using fast ramp MD simulations, and a technique for extracting plastic strain from MD simulations. All of these methods have been implemented in Sandia's LAMMPS MD code, ensuring their widespread availability to dynamic materials research at Sandia and elsewhere.

  2. A Coupling Tool for Parallel Molecular Dynamics-Continuum Simulations

    KAUST Repository

    Neumann, Philipp; Tchipev, Nikola

    2012-01-01

    We present a tool for coupling Molecular Dynamics and continuum solvers. It is written in C++ and is meant to support the developers of hybrid molecular - continuum simulations in terms of both realisation of the respective coupling algorithm

  3. Molecular Dynamics Study of Water Molecules in Interlayer of 14 ^|^Aring; Tobermorite

    KAUST Repository

    Yoon, Seyoon; Monteiro, Paulo J.M.

    2013-01-01

    The molecular structure and dynamics of interlayer water of 14 Å tobermorite are investigated based on molecular dynamics (MD) simulations. Calculated structural parameters of the interlayer water configuration are in good agreement with current

  4. Molecular Dynamics Simulations of Kinetic Models for Chiral Dominance in Soft Condensed Matter

    DEFF Research Database (Denmark)

    Toxvaerd, Søren

    2001-01-01

    Molecular dynamics simulation, models for isomerization kinetics, origin of biomolecular chirality......Molecular dynamics simulation, models for isomerization kinetics, origin of biomolecular chirality...

  5. molecular dynamics simulations and quantum chemical calculations

    African Journals Online (AJOL)

    ABSTRACT. The molecular dynamic (MD) simulation and quantum chemical calculations for the adsorption of [2-(2-Henicos-10- .... electronic properties of molecule clusters, surfaces and ... The local reactivity was analyzed by determining the.

  6. Invariant molecular-dynamics approach to structural phase transitions

    International Nuclear Information System (INIS)

    Wentzcovitch, R.M.

    1991-01-01

    Two fictitious Lagrangians to be used in molecular-dynamics simulations with variable cell shape and suitable to study problems like structural phase transitions are introduced. Because they are invariant with respect to the choice of the simulation cell edges and eliminate symmetry breaking associated with the fictitious part of the dynamics, they improve the physical content of numerical simulations that up to now have been done by using Parrinello-Rahman dynamics

  7. Extended Lagrangian Density Functional Tight-Binding Molecular Dynamics for Molecules and Solids

    International Nuclear Information System (INIS)

    Aradi, Balint; Frauenheim, Thomas

    2015-01-01

    A computationally fast quantum mechanical molecular dynamics scheme using an extended Lagrangian density functional tight-binding formulation has been developed and implemented in the DFTB+ electronic structure program package for simulations of solids and molecular systems. The scheme combines the computational speed of self-consistent density functional tight-binding theory with the efficiency and long-term accuracy of extended Lagrangian Born-Oppenheimer molecular dynamics. Furthermore, for systems without self-consistent charge instabilities, only a single diagonalization or construction of the single-particle density matrix is required in each time step. The molecular dynamics simulation scheme can also be applied to a broad range of problems in materials science, chemistry, and biology

  8. Easy GROMACS: A Graphical User Interface for GROMACS Molecular Dynamics Simulation Package

    Science.gov (United States)

    Dizkirici, Ayten; Tekpinar, Mustafa

    2015-03-01

    GROMACS is a widely used molecular dynamics simulation package. Since it is a command driven program, it is difficult to use this program for molecular biologists, biochemists, new graduate students and undergraduate researchers who are interested in molecular dynamics simulations. To alleviate the problem for those researchers, we wrote a graphical user interface that simplifies protein preparation for a classical molecular dynamics simulation. Our program can work with various GROMACS versions and it can perform essential analyses of GROMACS trajectories as well as protein preparation. We named our open source program `Easy GROMACS'. Easy GROMACS can give researchers more time for scientific research instead of dealing with technical intricacies.

  9. Extended Lagrangian Density Functional Tight-Binding Molecular Dynamics for Molecules and Solids.

    Science.gov (United States)

    Aradi, Bálint; Niklasson, Anders M N; Frauenheim, Thomas

    2015-07-14

    A computationally fast quantum mechanical molecular dynamics scheme using an extended Lagrangian density functional tight-binding formulation has been developed and implemented in the DFTB+ electronic structure program package for simulations of solids and molecular systems. The scheme combines the computational speed of self-consistent density functional tight-binding theory with the efficiency and long-term accuracy of extended Lagrangian Born-Oppenheimer molecular dynamics. For systems without self-consistent charge instabilities, only a single diagonalization or construction of the single-particle density matrix is required in each time step. The molecular dynamics simulation scheme can be applied to a broad range of problems in materials science, chemistry, and biology.

  10. NMR investigations of molecular dynamics

    Science.gov (United States)

    Palmer, Arthur

    2011-03-01

    NMR spectroscopy is a powerful experimental approach for characterizing protein conformational dynamics on multiple time scales. The insights obtained from NMR studies are complemented and by molecular dynamics (MD) simulations, which provide full atomistic details of protein dynamics. Homologous mesophilic (E. coli) and thermophilic (T. thermophilus) ribonuclease H (RNase H) enzymes serve to illustrate how changes in protein sequence and structure that affect conformational dynamic processes can be monitored and characterized by joint analysis of NMR spectroscopy and MD simulations. A Gly residue inserted within a putative hinge between helices B and C is conserved among thermophilic RNases H, but absent in mesophilic RNases H. Experimental spin relaxation measurements show that the dynamic properties of T. thermophilus RNase H are recapitulated in E. coli RNase H by insertion of a Gly residue between helices B and C. Additional specific intramolecular interactions that modulate backbone and sidechain dynamical properties of the Gly-rich loop and of the conserved Trp residue flanking the Gly insertion site have been identified using MD simulations and subsequently confirmed by NMR spin relaxation measurements. These results emphasize the importance of hydrogen bonds and local steric interactions in restricting conformational fluctuations, and the absence of such interactions in allowing conformational adaptation to substrate binding.

  11. Excitation dynamics and relaxation in a molecular heterodimer

    International Nuclear Information System (INIS)

    Balevičius, V.; Gelzinis, A.; Abramavicius, D.; Mančal, T.; Valkunas, L.

    2012-01-01

    Highlights: ► Dynamics of excitation within a heterogenous molecular dimer. ► Excited states can be swapped due to different reorganization energies of monomers. ► Conventional excitonic basis becomes renormalized due to interaction with the bath. ► Relaxation is independent of mutual positioning of monomeric excited states. -- Abstract: The exciton dynamics in a molecular heterodimer is studied as a function of differences in excitation and reorganization energies, asymmetry in transition dipole moments and excited state lifetimes. The heterodimer is composed of two molecules modeled as two-level systems coupled by the resonance interaction. The system-bath coupling is taken into account as a modulating factor of the molecular excitation energy gap, while the relaxation to the ground state is treated phenomenologically. Comparison of the description of the excitation dynamics modeled using either the Redfield equations (secular and full forms) or the Hierarchical quantum master equation (HQME) is demonstrated and discussed. Possible role of the dimer as an excitation quenching center in photosynthesis self-regulation is discussed. It is concluded that the system-bath interaction rather than the excitonic effect determines the excitation quenching ability of such a dimer.

  12. The nonequilibrium molecular dynamics

    International Nuclear Information System (INIS)

    Hoover, W.G.

    1992-03-01

    MOLECULAR DYNAMICS has been generalized in order to simulate a variety of NONEQUILIBRIUM systems. This generalization has been achieved by adopting microscopic mechanical definitions of macroscopic thermodynamic and hydrodynamic variables, such as temperature and stress. Some of the problems already treated include rapid plastic deformation, intense heat conduction, strong shockwaves simulation, and far-from-equilibrium phase transformations. Continuing advances in technique and in the modeling of interatomic forces, coupled with qualitative improvements in computer hardware, are enabling such simulations to approximate real-world microscale and nanoscale experiments

  13. Reaction dynamics of molecular hydrogen on silicon surfaces

    DEFF Research Database (Denmark)

    Bratu, P.; Brenig, W.; Gross, A.

    1996-01-01

    of the preexponential factor by about one order of magnitude per lateral degree of freedom. Molecular vibrations have practically no effect on the adsorption/desorption dynamics itself, but lead to vibrational heating in desorption with a strong isotope effect. Ab initio calculations for the H-2 interaction...... between the two surfaces. These results indicate that tunneling, molecular vibrations, and the structural details of the surface play only a minor role for the adsorption dynamics. Instead, they appear to be governed by the localized H-Si bonding and Si-Si lattice vibrations. Theoretically, an effective......Experimental and theoretical results on the dynamics of dissociative adsorption and recombinative desorption of hydrogen on silicon are presented. Using optical second-harmonic generation, extremely small sticking probabilities in the range 10(-9)-10(-5) could be measured for H-2 and D-2 on Si(111...

  14. Scalability of Sustainable Business Models in Hybrid Organizations

    Directory of Open Access Journals (Sweden)

    Adam Jabłoński

    2016-02-01

    Full Text Available The dynamics of change in modern business create new mechanisms for company management to determine their pursuit and the achievement of their high performance. This performance maintained over a long period of time becomes a source of ensuring business continuity by companies. An ontological being enabling the adoption of such assumptions is such a business model that has the ability to generate results in every possible market situation and, moreover, it has the features of permanent adaptability. A feature that describes the adaptability of the business model is its scalability. Being a factor ensuring more work and more efficient work with an increasing number of components, scalability can be applied to the concept of business models as the company’s ability to maintain similar or higher performance through it. Ensuring the company’s performance in the long term helps to build the so-called sustainable business model that often balances the objectives of stakeholders and shareholders, and that is created by the implemented principles of value-based management and corporate social responsibility. This perception of business paves the way for building hybrid organizations that integrate business activities with pro-social ones. The combination of an approach typical of hybrid organizations in designing and implementing sustainable business models pursuant to the scalability criterion seems interesting from the cognitive point of view. Today, hybrid organizations are great spaces for building effective and efficient mechanisms for dialogue between business and society. This requires the appropriate business model. The purpose of the paper is to present the conceptualization and operationalization of scalability of sustainable business models that determine the performance of a hybrid organization in the network environment. The paper presents the original concept of applying scalability in sustainable business models with detailed

  15. State-to-state dynamics of molecular energy transfer

    Energy Technology Data Exchange (ETDEWEB)

    Gentry, W.R.; Giese, C.F. [Univ. of Minnesota, Minneapolis (United States)

    1993-12-01

    The goal of this research program is to elucidate the elementary dynamical mechanisms of vibrational and rotational energy transfer between molecules, at a quantum-state resolved level of detail. Molecular beam techniques are used to isolate individual molecular collisions, and to control the kinetic energy of collision. Lasers are used both to prepare specific quantum states prior to collision by stimulated-emission pumping (SEP), and to measure the distribution of quantum states in the collision products by laser-induced fluorescence (LIF). The results are interpreted in terms of dynamical models, which may be cast in a classical, semiclassical or quantum mechanical framework, as appropriate.

  16. Line-shape theory and molecular dynamics in collision-induced light scattering

    International Nuclear Information System (INIS)

    Balucani, U.; Tognetti, V.; Vallauri, R.

    1979-01-01

    Molecular-dynamics studies in argon at 148 amagats are presented for gaining information on the dynamical properties responsible for the depolarized light scattering from simple fluids. The total and pair-correlation functions are computed within the simple dipole--induced-dipole model of polarizability anisotropy. The pair spectral shape is derived. These results are compared with a theoretical analysis based on a continued-fraction approach. The necessary frequency moments are calculated both in the low-density limit and taking into account first-order density corrections, and compared with the molecular-dynamics data. The agreement between the theoretical spectra and molecular-dynamics data shows the validity of the memory-function approach. The comparison with the real experimental results allows one to test the relevant physical contributions to the polarizability anisotropy

  17. Coulomb interactions via local dynamics: a molecular-dynamics algorithm

    International Nuclear Information System (INIS)

    Pasichnyk, Igor; Duenweg, Burkhard

    2004-01-01

    We derive and describe in detail a recently proposed method for obtaining Coulomb interactions as the potential of mean force between charges which are dynamically coupled to a local electromagnetic field. We focus on the molecular dynamics version of the method and show that it is intimately related to the Car-Parrinello approach, while being equivalent to solving Maxwell's equations with a freely adjustable speed of light. Unphysical self-energies arise as a result of the lattice interpolation of charges, and are corrected by a subtraction scheme based on the exact lattice Green function. The method can be straightforwardly parallelized using standard domain decomposition. Some preliminary benchmark results are presented

  18. Protein Dynamics in Organic Media at Varying Water Activity Studied by Molecular Dynamics Simulation

    DEFF Research Database (Denmark)

    Wedberg, Nils Hejle Rasmus Ingemar; Abildskov, Jens; Peters, Günther H.J.

    2012-01-01

    In nonaqueous enzymology, control of enzyme hydration is commonly approached by fixing the thermodynamic water activity of the medium. In this work, we present a strategy for evaluating the water activity in molecular dynamics simulations of proteins in water/organic solvent mixtures. The method...... relies on determining the water content of the bulk phase and uses a combination of Kirkwood−Buff theory and free energy calculations to determine corresponding activity coefficients. We apply the method in a molecular dynamics study of Candida antarctica lipase B in pure water and the organic solvents...

  19. Pitfall in quantum mechanical/molecular mechanical molecular dynamics simulation of small solutes in solution.

    Science.gov (United States)

    Hu, Hao; Liu, Haiyan

    2013-05-30

    Developments in computing hardware and algorithms have made direct molecular dynamics simulation with the combined quantum mechanical/molecular mechanical methods affordable for small solute molecules in solution, in which much improved accuracy can be obtained via the quantum mechanical treatment of the solute molecule and even sometimes water molecules in the first solvation shell. However, unlike the conventional molecular mechanical simulations of large molecules, e.g., proteins, in solutions, special care must be taken in the technical details of the simulation, including the thermostat of the solute/solvent system, so that the conformational space of the solute molecules can be properly sampled. We show here that the common setup for classical molecular mechanical molecular dynamics simulations, such as the Berendsen or single Nose-Hoover thermostat, and/or rigid water models could lead to pathological sampling of the solutes' conformation. In the extreme example of a methanol molecule in aqueous solution, improper and sluggish setups could generate two peaks in the distribution of the O-H bond length. We discuss the factors responsible for this somewhat unexpected result and evoke a simple and ancient technical fix-up to resolve this problem.

  20. Novel flat datacenter network architecture based on scalable and flow-controlled optical switch system

    NARCIS (Netherlands)

    Miao, W.; Luo, J.; Di Lucente, S.; Dorren, H.J.S.; Calabretta, N.

    2013-01-01

    We propose and demonstrate an optical flat datacenter network based on scalable optical switch system with optical flow control. 4×4 dynamic switch operation at 40 Gb/s reported 300ns minimum end-to-end latency (including 25m transmission link) and

  1. Ab initio molecular dynamics in a finite homogeneous electric field.

    Science.gov (United States)

    Umari, P; Pasquarello, Alfredo

    2002-10-07

    We treat homogeneous electric fields within density functional calculations with periodic boundary conditions. A nonlocal energy functional depending on the applied field is used within an ab initio molecular dynamics scheme. The reliability of the method is demonstrated in the case of bulk MgO for the Born effective charges, and the high- and low-frequency dielectric constants. We evaluate the static dielectric constant by performing a damped molecular dynamics in an electric field and avoiding the calculation of the dynamical matrix. Application of this method to vitreous silica shows good agreement with experiment and illustrates its potential for systems of large size.

  2. Scalable Task Assignment for Heterogeneous Multi-Robot Teams

    Directory of Open Access Journals (Sweden)

    Paula García

    2013-02-01

    Full Text Available This work deals with the development of a dynamic task assignment strategy for heterogeneous multi-robot teams in typical real world scenarios. The strategy must be efficiently scalable to support problems of increasing complexity with minimum designer intervention. To this end, we have selected a very simple auction-based strategy, which has been implemented and analysed in a multi-robot cleaning problem that requires strong coordination and dynamic complex subtask organization. We will show that the selection of a simple auction strategy provides a linear computational cost increase with the number of robots that make up the team and allows the solving of highly complex assignment problems in dynamic conditions by means of a hierarchical sub-auction policy. To coordinate and control the team, a layered behaviour-based architecture has been applied that allows the reusing of the auction-based strategy to achieve different coordination levels.

  3. Adaptive format conversion for scalable video coding

    Science.gov (United States)

    Wan, Wade K.; Lim, Jae S.

    2001-12-01

    The enhancement layer in many scalable coding algorithms is composed of residual coding information. There is another type of information that can be transmitted instead of (or in addition to) residual coding. Since the encoder has access to the original sequence, it can utilize adaptive format conversion (AFC) to generate the enhancement layer and transmit the different format conversion methods as enhancement data. This paper investigates the use of adaptive format conversion information as enhancement data in scalable video coding. Experimental results are shown for a wide range of base layer qualities and enhancement bitrates to determine when AFC can improve video scalability. Since the parameters needed for AFC are small compared to residual coding, AFC can provide video scalability at low enhancement layer bitrates that are not possible with residual coding. In addition, AFC can also be used in addition to residual coding to improve video scalability at higher enhancement layer bitrates. Adaptive format conversion has not been studied in detail, but many scalable applications may benefit from it. An example of an application that AFC is well-suited for is the migration path for digital television where AFC can provide immediate video scalability as well as assist future migrations.

  4. Note: Local thermal conductivities from boundary driven non-equilibrium molecular dynamics simulations

    International Nuclear Information System (INIS)

    Bresme, F.; Armstrong, J.

    2014-01-01

    We report non-equilibrium molecular dynamics simulations of heat transport in models of molecular fluids. We show that the “local” thermal conductivities obtained from non-equilibrium molecular dynamics simulations agree within numerical accuracy with equilibrium Green-Kubo computations. Our results support the local equilibrium hypothesis for transport properties. We show how to use the local dependence of the thermal gradients to quantify the thermal conductivity of molecular fluids for a wide range of thermodynamic states using a single simulation

  5. Scalable Creation of Long-Lived Multipartite Entanglement

    Science.gov (United States)

    Kaufmann, H.; Ruster, T.; Schmiegelow, C. T.; Luda, M. A.; Kaushal, V.; Schulz, J.; von Lindenfels, D.; Schmidt-Kaler, F.; Poschinger, U. G.

    2017-10-01

    We demonstrate the deterministic generation of multipartite entanglement based on scalable methods. Four qubits are encoded in 40Ca+, stored in a microstructured segmented Paul trap. These qubits are sequentially entangled by laser-driven pairwise gate operations. Between these, the qubit register is dynamically reconfigured via ion shuttling operations, where ion crystals are separated and merged, and ions are moved in and out of a fixed laser interaction zone. A sequence consisting of three pairwise entangling gates yields a four-ion Greenberger-Horne-Zeilinger state |ψ ⟩=(1 /√{2 })(|0000 ⟩+|1111 ⟩) , and full quantum state tomography reveals a state fidelity of 94.4(3)%. We analyze the decoherence of this state and employ dynamic decoupling on the spatially distributed constituents to maintain 69(5)% coherence at a storage time of 1.1 sec.

  6. Fermionic molecular dynamics for colliding and decaying nuclei

    International Nuclear Information System (INIS)

    Feldmeier, H.; Schnack, J.

    1993-11-01

    Fermionic Molecular Dynamics models a system of fermions by means of a trial many-body state composed of an antisymmetrized product of single-particle states which are localized gaussians in coordinate and momentum space. The parameters specifying them are the analogue to the variables in classical molecular dynamics. The time-dependent variational principle yields the equations of motion which are solved for collisions of 12 C+ 12 C and deexcitations of 12 C. The collisions show a great variety of phenomena including explosion, sequential fragmentation and multifragmentation. The deexcitation for nuclei with E * /A ∼ 5MeV is dominated by particle evaporation on time scales of the order of 10 -20 s or longer. (orig.)

  7. Optical spectra and lattice dynamics of molecular crystals

    CERN Document Server

    Zhizhin, GN

    1995-01-01

    The current volume is a single topic volume on the optical spectra and lattice dynamics of molecular crystals. The book is divided into two parts. Part I covers both the theoretical and experimental investigations of organic crystals. Part II deals with the investigation of the structure, phase transitions and reorientational motion of molecules in organic crystals. In addition appendices are given which provide the parameters for the calculation of the lattice dynamics of molecular crystals, procedures for the calculation of frequency eigenvectors of utilizing computers, and the frequencies and eigenvectors of lattice modes for several organic crystals. Quite a large amount of Russian literature is cited, some of which has previously not been available to scientists in the West.

  8. Molecular dynamics studies of the dynamics of supercooled Lennard-Jones liquids

    International Nuclear Information System (INIS)

    De Leeuw, S.W.; Brakkee, M.J.D.

    1990-01-01

    Results are presented of molecular dynamics experiments, in which the Lennard-Jones liquid is cooled isobarically into the metastable temperature region below the freezing temperature. The variation of the density-density and transverse current correlation functions with temperature is studied. We observed a power-law behaviour for the temperature dependence of dynamical properties (viscosity and coefficienty of self-diffusion) with an exponent in good agreement with prediction of mode coupling theories and recent experimental results. (author). 23 refs, 5 figs

  9. Orbital free molecular dynamics; Approche sans orbitale des plasmas denses

    Energy Technology Data Exchange (ETDEWEB)

    Lambert, F

    2007-08-15

    The microscopic properties of hot and dense plasmas stay a field essentially studied thanks to classical theories like the One Component Plasma, models which rely on free parameters, particularly ionization. In order to investigate these systems, we have used, in this PhD work, a semi-classical model, without free parameters, that is based on coupling consistently classical molecular dynamics for the nuclei and orbital free density functional theory for the electrons. The electronic fluid is represented by a free energy entirely determined by the local density. This approximation was validated by a comparison with an ab initio technique, quantum molecular dynamics. This one is identical to the previous except for the description of the free energy that depends on a quantum-independent-particle model. Orbital free molecular dynamics was then used to compute equation of state of boron and iron plasmas in the hot and dense regime. Furthermore, comparisons with classical theories were performed on structural and dynamical properties. Finally, equation of state and transport coefficients mixing laws were studied by direct simulation of a plasma composed of deuterium and copper. (author)

  10. Preserving the Boltzmann ensemble in replica-exchange molecular dynamics.

    Science.gov (United States)

    Cooke, Ben; Schmidler, Scott C

    2008-10-28

    We consider the convergence behavior of replica-exchange molecular dynamics (REMD) [Sugita and Okamoto, Chem. Phys. Lett. 314, 141 (1999)] based on properties of the numerical integrators in the underlying isothermal molecular dynamics (MD) simulations. We show that a variety of deterministic algorithms favored by molecular dynamics practitioners for constant-temperature simulation of biomolecules fail either to be measure invariant or irreducible, and are therefore not ergodic. We then show that REMD using these algorithms also fails to be ergodic. As a result, the entire configuration space may not be explored even in an infinitely long simulation, and the simulation may not converge to the desired equilibrium Boltzmann ensemble. Moreover, our analysis shows that for initial configurations with unfavorable energy, it may be impossible for the system to reach a region surrounding the minimum energy configuration. We demonstrate these failures of REMD algorithms for three small systems: a Gaussian distribution (simple harmonic oscillator dynamics), a bimodal mixture of Gaussians distribution, and the alanine dipeptide. Examination of the resulting phase plots and equilibrium configuration densities indicates significant errors in the ensemble generated by REMD simulation. We describe a simple modification to address these failures based on a stochastic hybrid Monte Carlo correction, and prove that this is ergodic.

  11. Orthonormal Wavelet Bases for Quantum Molecular Dynamics

    International Nuclear Information System (INIS)

    Tymczak, C.; Wang, X.

    1997-01-01

    We report on the use of compactly supported, orthonormal wavelet bases for quantum molecular-dynamics (Car-Parrinello) algorithms. A wavelet selection scheme is developed and tested for prototypical problems, such as the three-dimensional harmonic oscillator, the hydrogen atom, and the local density approximation to atomic and molecular systems. Our method shows systematic convergence with increased grid size, along with improvement on compression rates, thereby yielding an optimal grid for self-consistent electronic structure calculations. copyright 1997 The American Physical Society

  12. Non-Adiabatic Molecular Dynamics Methods for Materials Discovery

    Energy Technology Data Exchange (ETDEWEB)

    Furche, Filipp [Univ. of California, Irvine, CA (United States); Parker, Shane M. [Univ. of California, Irvine, CA (United States); Muuronen, Mikko J. [Univ. of California, Irvine, CA (United States); Roy, Saswata [Univ. of California, Irvine, CA (United States)

    2017-04-04

    The flow of radiative energy in light-driven materials such as photosensitizer dyes or photocatalysts is governed by non-adiabatic transitions between electronic states and cannot be described within the Born-Oppenheimer approximation commonly used in electronic structure theory. The non-adiabatic molecular dynamics (NAMD) methods based on Tully surface hopping and time-dependent density functional theory developed in this project have greatly extended the range of molecular materials that can be tackled by NAMD simulations. New algorithms to compute molecular excited state and response properties efficiently were developed. Fundamental limitations of common non-linear response methods were discovered and characterized. Methods for accurate computations of vibronic spectra of materials such as black absorbers were developed and applied. It was shown that open-shell TDDFT methods capture bond breaking in NAMD simulations, a longstanding challenge for single-reference molecular dynamics simulations. The methods developed in this project were applied to study the photodissociation of acetaldehyde and revealed that non-adiabatic effects are experimentally observable in fragment kinetic energy distributions. Finally, the project enabled the first detailed NAMD simulations of photocatalytic water oxidation by titania nanoclusters, uncovering the mechanism of this fundamentally important reaction for fuel generation and storage.

  13. Dynamic combinatorial libraries based on hydrogen-bonde molecular boxes

    NARCIS (Netherlands)

    Kerckhoffs, J.M.C.A.; Mateos timoneda, Miguel; Reinhoudt, David; Crego Calama, Mercedes

    2007-01-01

    This article describes two different types of dynamic combinatorial libraries of host and guest molecules. The first part of this article describes the encapsulation of alizarin trimer 2 a3 by dynamic mixtures of up to twenty different self-assembled molecular receptors together with the

  14. Molecular dynamics for reactions of heterogeneous catalysis

    NARCIS (Netherlands)

    Jansen, A.P.J.; Brongersma, H.H.; Santen, van R.A.

    1991-01-01

    An overview is given of Molecular Dynamics, and numerical integration techniques, system initialization, boundary conditions, force representation, statistics, system size, and simulations duration are discussed. Examples from surface science are used to illustrate the pros and cons of the method.

  15. Molecular dynamics simulations on PGLa using NMR orientational constraints

    Energy Technology Data Exchange (ETDEWEB)

    Sternberg, Ulrich, E-mail: ulrich.sternberg@partner.kit.edu; Witter, Raiker [Tallinn University of Technology, Technomedicum (Estonia)

    2015-11-15

    NMR data obtained by solid state NMR from anisotropic samples are used as orientational constraints in molecular dynamics simulations for determining the structure and dynamics of the PGLa peptide within a membrane environment. For the simulation the recently developed molecular dynamics with orientational constraints technique (MDOC) is used. This method introduces orientation dependent pseudo-forces into the COSMOS-NMR force field. Acting during a molecular dynamics simulation these forces drive molecular rotations, re-orientations and folding in such a way that the motional time-averages of the tensorial NMR properties are consistent with the experimentally measured NMR parameters. This MDOC strategy does not depend on the initial choice of atomic coordinates, and is in principle suitable for any flexible and mobile kind of molecule; and it is of course possible to account for flexible parts of peptides or their side-chains. MDOC has been applied to the antimicrobial peptide PGLa and a related dimer model. With these simulations it was possible to reproduce most NMR parameters within the experimental error bounds. The alignment, conformation and order parameters of the membrane-bound molecule and its dimer were directly derived with MDOC from the NMR data. Furthermore, this new approach yielded for the first time the distribution of segmental orientations with respect to the membrane and the order parameter tensors of the dimer systems. It was demonstrated the deuterium splittings measured at the peptide to lipid ratio of 1/50 are consistent with a membrane spanning orientation of the peptide.

  16. Scalable Density-Based Subspace Clustering

    DEFF Research Database (Denmark)

    Müller, Emmanuel; Assent, Ira; Günnemann, Stephan

    2011-01-01

    For knowledge discovery in high dimensional databases, subspace clustering detects clusters in arbitrary subspace projections. Scalability is a crucial issue, as the number of possible projections is exponential in the number of dimensions. We propose a scalable density-based subspace clustering...... method that steers mining to few selected subspace clusters. Our novel steering technique reduces subspace processing by identifying and clustering promising subspaces and their combinations directly. Thereby, it narrows down the search space while maintaining accuracy. Thorough experiments on real...... and synthetic databases show that steering is efficient and scalable, with high quality results. For future work, our steering paradigm for density-based subspace clustering opens research potential for speeding up other subspace clustering approaches as well....

  17. Molecular dynamics simulations

    International Nuclear Information System (INIS)

    Alder, B.J.

    1985-07-01

    The molecular dynamics computer simulation discovery of the slow decay of the velocity autocorrelation function in fluids is briefly reviewed in order to contrast that long time tail with those observed for the stress autocorrelation function in fluids and the velocity autocorrelation function in the Lorentz gas. For a non-localized particle in the Lorentz gas it is made plausible that even if it behaved quantum mechanically its long time tail would be the same as the classical one. The generalization of Fick's law for diffusion for the Lorentz gas, necessary to avoid divergences due to the slow decay of correlations, is presented. For fluids, that generalization has not yet been established, but the region of validity of generalized hydrodynamics is discussed. 20 refs., 5 figs

  18. A new algorithm for extended nonequilibrium molecular dynamics simulations of mixed flow

    NARCIS (Netherlands)

    Hunt, T.A.; Hunt, Thomas A.; Bernardi, Stefano; Todd, B.D.

    2010-01-01

    In this work, we develop a new algorithm for nonequilibrium molecular dynamics of fluids under planar mixed flow, a linear combination of planar elongational flow and planar Couette flow. To date, the only way of simulating mixed flow using nonequilibrium molecular dynamics techniques was to impose

  19. A Flexible, Grid-Enabled Web Portal for GROMACS Molecular Dynamics Simulations

    NARCIS (Netherlands)

    van Dijk, Marc; Wassenaar, Tsjerk A; Bonvin, Alexandre M J J

    2012-01-01

    Molecular dynamics simulations are becoming a standard part of workflows in structural biology. They are used for tasks as diverse as assessing molecular flexibility, probing conformational changes, assessing the impact of mutations, or gaining information about molecular interactions. However,

  20. A flexible, grid-enabled web portal for GROMACS molecular dynamics simulations

    NARCIS (Netherlands)

    van Dijk, M.; Wassenaar, T.A.; Bonvin, A.M.J.J.

    2012-01-01

    Molecular dynamics simulations are becoming a standard part of workflows in structural biology. They are used for tasks as diverse as assessing molecular flexibility, probing conformational changes, assessing the impact of mutations, or gaining information about molecular interactions. However,

  1. Scalable devices

    KAUST Repository

    Krü ger, Jens J.; Hadwiger, Markus

    2014-01-01

    In computer science in general and in particular the field of high performance computing and supercomputing the term scalable plays an important role. It indicates that a piece of hardware, a concept, an algorithm, or an entire system scales

  2. Vortex Filaments in Grids for Scalable, Fine Smoke Simulation.

    Science.gov (United States)

    Meng, Zhang; Weixin, Si; Yinling, Qian; Hanqiu, Sun; Jing, Qin; Heng, Pheng-Ann

    2015-01-01

    Vortex modeling can produce attractive visual effects of dynamic fluids, which are widely applicable for dynamic media, computer games, special effects, and virtual reality systems. However, it is challenging to effectively simulate intensive and fine detailed fluids such as smoke with fast increasing vortex filaments and smoke particles. The authors propose a novel vortex filaments in grids scheme in which the uniform grids dynamically bridge the vortex filaments and smoke particles for scalable, fine smoke simulation with macroscopic vortex structures. Using the vortex model, their approach supports the trade-off between simulation speed and scale of details. After computing the whole velocity, external control can be easily exerted on the embedded grid to guide the vortex-based smoke motion. The experimental results demonstrate the efficiency of using the proposed scheme for a visually plausible smoke simulation with macroscopic vortex structures.

  3. Reaction dynamics in polyatomic molecular systems

    Energy Technology Data Exchange (ETDEWEB)

    Miller, W.H. [Lawrence Berkeley Laboratory, CA (United States)

    1993-12-01

    The goal of this program is the development of theoretical methods and models for describing the dynamics of chemical reactions, with specific interest for application to polyatomic molecular systems of special interest and relevance. There is interest in developing the most rigorous possible theoretical approaches and also in more approximate treatments that are more readily applicable to complex systems.

  4. Energy conservation in molecular dynamics simulations of classical systems

    DEFF Research Database (Denmark)

    Toxværd, Søren; Heilmann, Ole; Dyre, J. C.

    2012-01-01

    Classical Newtonian dynamics is analytic and the energy of an isolated system is conserved. The energy of such a system, obtained by the discrete “Verlet” algorithm commonly used in molecular dynamics simulations, fluctuates but is conserved in the mean. This is explained by the existence...

  5. Implementation of surface hopping molecular dynamics using semiempirical methods

    International Nuclear Information System (INIS)

    Fabiano, E.; Keal, T.W.; Thiel, W.

    2008-01-01

    A molecular dynamics driver and surface hopping algorithm for nonadiabatic dynamics has been implemented in a development version of the MNDO semiempirical electronic structure package. The required energies, gradients and nonadiabatic couplings are efficiently evaluated on the fly using semiempirical configuration interaction methods. The choice of algorithms for the time evolution of the nuclear motion and quantum amplitudes is discussed, and different schemes for the computation of nonadiabatic couplings are analysed. The importance of molecular orbital tracking and electronic state following is underlined in the context of configuration interaction calculations. The method is applied to three case studies (ethylene, methaniminium ion, and methanimine) using the orthogonalization corrected OM2 Hamiltonian. In all three cases decay times and dynamics paths similar to high-level ab initio results are obtained

  6. Ab Initio molecular dynamics with excited electrons

    NARCIS (Netherlands)

    Alavi, A.; Kohanoff, J.; Parrinello, M.; Frenkel, D.

    1994-01-01

    A method to do ab initio molecular dynamics suitable for metallic and electronically hot systems is described. It is based on a density functional which is costationary with the finite-temperature functional of Mermin, with state being included with possibly fractional occupation numbers.

  7. Molecular dynamics coupled with a virtual system for effective conformational sampling.

    Science.gov (United States)

    Hayami, Tomonori; Kasahara, Kota; Nakamura, Haruki; Higo, Junichi

    2018-07-15

    An enhanced conformational sampling method is proposed: virtual-system coupled canonical molecular dynamics (VcMD). Although VcMD enhances sampling along a reaction coordinate, this method is free from estimation of a canonical distribution function along the reaction coordinate. This method introduces a virtual system that does not necessarily obey a physical law. To enhance sampling the virtual system couples with a molecular system to be studied. Resultant snapshots produce a canonical ensemble. This method was applied to a system consisting of two short peptides in an explicit solvent. Conventional molecular dynamics simulation, which is ten times longer than VcMD, was performed along with adaptive umbrella sampling. Free-energy landscapes computed from the three simulations mutually converged well. The VcMD provided quicker association/dissociation motions of peptides than the conventional molecular dynamics did. The VcMD method is applicable to various complicated systems because of its methodological simplicity. © 2018 Wiley Periodicals, Inc. © 2018 Wiley Periodicals, Inc.

  8. Molecular packing in 1-hexanol-DMPC bilayers studied by molecular dynamics simulation

    DEFF Research Database (Denmark)

    Pedersen, U.R.; Peters, Günther H.j.; Westh, P.

    2007-01-01

    The structure and molecular packing density of a “mismatched” solute, 1-hexanol, in lipid membranes of dimyristoyl phosphatidylcholine (DMPC) was studied by molecular dynamics simulations. We found that the average location and orientation of the hexanol molecules matched earlier experimental data...... on comparable systems. The local density or molecular packing in DMPC–hexanol was elucidated through the average Voronoi volumes of all heavy (non-hydrogen) atoms. Analogous analysis was conducted on trajectories from simulations of pure 1-hexanol and pure (hydrated) DMPC bilayers. The results suggested...... of the alcohol upon partitioning and an even stronger loosening in the packing of the lipid. Furthermore, analysis of Voronoi volumes along the membrane normal identifies a distinctive depth dependence of the changes in molecular packing. The outer (interfacial) part of the lipid acyl chains (up to C8...

  9. Nanomaterials under extreme environments: A study of structural and dynamic properties using reactive molecular dynamics simulations

    Science.gov (United States)

    Shekhar, Adarsh

    Nanotechnology is becoming increasingly important with the continuing advances in experimental techniques. As researchers around the world are trying to expand the current understanding of the behavior of materials at the atomistic scale, the limited resolution of equipment, both in terms of time and space, act as roadblocks to a comprehensive study. Numerical methods, in general and molecular dynamics, in particular act as able compliment to the experiments in our quest for understanding material behavior. In this research work, large scale molecular dynamics simulations to gain insight into the mechano-chemical behavior under extreme conditions of a variety of systems with many real world applications. The body of this work is divided into three parts, each covering a particular system: 1) Aggregates of aluminum nanoparticles are good solid fuel due to high flame propagation rates. Multi-million atom molecular dynamics simulations reveal the mechanism underlying higher reaction rate in a chain of aluminum nanoparticles as compared to an isolated nanoparticle. This is due to the penetration of hot atoms from reacting nanoparticles to an adjacent, unreacted nanoparticle, which brings in external heat and initiates exothermic oxidation reactions. 2) Cavitation bubbles readily occur in fluids subjected to rapid changes in pressure. We use billion-atom reactive molecular dynamics simulations on a 163,840-processor BlueGene/P supercomputer to investigate chemical and mechanical damages caused by shock-induced collapse of nanobubbles in water near amorphous silica. Collapse of an empty nanobubble generates high-speed nanojet, resulting in the formation of a pit on the surface. The pit contains a large number of silanol groups and its volume is found to be directly proportional to the volume of the nanobubble. The gas-filled bubbles undergo partial collapse and consequently the damage on the silica surface is mitigated. 3) The structure and dynamics of water confined in

  10. Gas-Phase Molecular Dynamics: Theoretical Studies In Spectroscopy and Chemical Dynamics

    Energy Technology Data Exchange (ETDEWEB)

    Yu H. G.; Muckerman, J.T.

    2012-05-29

    The main goal of this program is the development and application of computational methods for studying chemical reaction dynamics and molecular spectroscopy in the gas phase. We are interested in developing rigorous quantum dynamics algorithms for small polyatomic systems and in implementing approximate approaches for complex ones. Particular focus is on the dynamics and kinetics of chemical reactions and on the rovibrational spectra of species involved in combustion processes. This research also explores the potential energy surfaces of these systems of interest using state-of-the-art quantum chemistry methods, and extends them to understand some important properties of materials in condensed phases and interstellar medium as well as in combustion environments.

  11. Parallel scalability of Hartree-Fock calculations

    Science.gov (United States)

    Chow, Edmond; Liu, Xing; Smelyanskiy, Mikhail; Hammond, Jeff R.

    2015-03-01

    Quantum chemistry is increasingly performed using large cluster computers consisting of multiple interconnected nodes. For a fixed molecular problem, the efficiency of a calculation usually decreases as more nodes are used, due to the cost of communication between the nodes. This paper empirically investigates the parallel scalability of Hartree-Fock calculations. The construction of the Fock matrix and the density matrix calculation are analyzed separately. For the former, we use a parallelization of Fock matrix construction based on a static partitioning of work followed by a work stealing phase. For the latter, we use density matrix purification from the linear scaling methods literature, but without using sparsity. When using large numbers of nodes for moderately sized problems, density matrix computations are network-bandwidth bound, making purification methods potentially faster than eigendecomposition methods.

  12. Molecular dynamics simulation of self-diffusion coefficients for liquid metals

    International Nuclear Information System (INIS)

    Ju Yuan-Yuan; Zhang Qing-Ming; Gong Zi-Zheng; Ji Guang-Fu

    2013-01-01

    The temperature-dependent coefficients of self-diffusion for liquid metals are simulated by molecular dynamics methods based on the embedded-atom-method (EAM) potential function. The simulated results show that a good inverse linear relation exists between the natural logarithm of self-diffusion coefficients and temperature, though the results in the literature vary somewhat, due to the employment of different potential functions. The estimated activation energy of liquid metals obtained by fitting the Arrhenius formula is close to the experimental data. The temperature-dependent shear-viscosities obtained from the Stokes—Einstein relation in conjunction with the results of molecular dynamics simulation are generally consistent with other values in the literature. (atomic and molecular physics)

  13. Molecular mechanism of allosteric communication in Hsp70 revealed by molecular dynamics simulations.

    Directory of Open Access Journals (Sweden)

    Federica Chiappori

    Full Text Available Investigating ligand-regulated allosteric coupling between protein domains is fundamental to understand cell-life regulation. The Hsp70 family of chaperones represents an example of proteins in which ATP binding and hydrolysis at the Nucleotide Binding Domain (NBD modulate substrate recognition at the Substrate Binding Domain (SBD. Herein, a comparative analysis of an allosteric (Hsp70-DnaK and a non-allosteric structural homolog (Hsp110-Sse1 of the Hsp70 family is carried out through molecular dynamics simulations, starting from different conformations and ligand-states. Analysis of ligand-dependent modulation of internal fluctuations and local deformation patterns highlights the structural and dynamical changes occurring at residue level upon ATP-ADP exchange, which are connected to the conformational transition between closed and open structures. By identifying the dynamically responsive protein regions and specific cross-domain hydrogen-bonding patterns that differentiate Hsp70 from Hsp110 as a function of the nucleotide, we propose a molecular mechanism for the allosteric signal propagation of the ATP-encoded conformational signal.

  14. Catalysis and communication in dynamic molecular networks

    NARCIS (Netherlands)

    Fanlo Virgos, Hugo

    2015-01-01

    The interactions of a Dynamic Combinatorial Library (DCL) of molecules with specific targets leads to composition changes of the library which can reveal potential guests and / or catalysts. In this thesis some chemical systems have been proposed to achieve a certain level of molecular complexity

  15. Molecular dynamics study of atomic displacements in disordered solid alloys

    Science.gov (United States)

    Puzyrev, Yevgeniy S.

    The effects of atomic displacements on the energetics of alloys plays important role in the determining the properties of alloys. We studied the atomic displacements in disordered solid alloys using molecular dynamics and Monte-Carlo methods. The diffuse scattering of pure materials, copper, gold, nickel, and palladium was calculated. The experimental data for pure Cu was obtained from diffuse scattering intensity of synchrotron x-ray radiation. The comparison showed the advantages of molecular dynamics method for calculating the atomic displacements in solid alloys. The individual nearest neighbor separations were calculated for Cu 50Au50 alloy and compared to the result of XAFS experiment. The molecular dynamics method provided theoretical predictions of nearest neighbor pair separations in other binary alloys, Cu-Pd and Cu-Al for wide range of the concentrations. We also experimentally recovered the diffuse scattering maps for the Cu47.3Au52.7 and Cu85.2Al14.8 alloy.

  16. Bridging the gap between molecular dynamics simulations and phase-field modelling: dynamics of a [NixZr1-x]liquid-Zrcrystal solidification front

    International Nuclear Information System (INIS)

    Danilov, Denis; Nestler, Britta; Guerdane, Mohammed; Teichler, Helmar

    2009-01-01

    Results are presented from phase-field modelling and molecular dynamics simulations concerning the relaxation dynamics in a finite-temperature two-phase crystal-liquid sample subjected to an abrupt temperature drop. Relaxation takes place by propagation of the solidification front under formation of a spatially varying concentration profile in the melt. The molecular dynamics simulations are carried out with an interatomic model appropriate for the NiZr alloy system and provide the thermophysical data required for setting up the phase-field simulations. Regarding the concentration profile and velocity of the solidification front, best agreement between the phase-field model and molecular dynamics simulation is obtained when increasing the apparent diffusion coefficients in the phase-field treatment by a factor of four against their molecular dynamics estimates.

  17. Visualizing functional motions of membrane transporters with molecular dynamics simulations.

    Science.gov (United States)

    Shaikh, Saher A; Li, Jing; Enkavi, Giray; Wen, Po-Chao; Huang, Zhijian; Tajkhorshid, Emad

    2013-01-29

    Computational modeling and molecular simulation techniques have become an integral part of modern molecular research. Various areas of molecular sciences continue to benefit from, indeed rely on, the unparalleled spatial and temporal resolutions offered by these technologies, to provide a more complete picture of the molecular problems at hand. Because of the continuous development of more efficient algorithms harvesting ever-expanding computational resources, and the emergence of more advanced and novel theories and methodologies, the scope of computational studies has expanded significantly over the past decade, now including much larger molecular systems and far more complex molecular phenomena. Among the various computer modeling techniques, the application of molecular dynamics (MD) simulation and related techniques has particularly drawn attention in biomolecular research, because of the ability of the method to describe the dynamical nature of the molecular systems and thereby to provide a more realistic representation, which is often needed for understanding fundamental molecular properties. The method has proven to be remarkably successful in capturing molecular events and structural transitions highly relevant to the function and/or physicochemical properties of biomolecular systems. Herein, after a brief introduction to the method of MD, we use a number of membrane transport proteins studied in our laboratory as examples to showcase the scope and applicability of the method and its power in characterizing molecular motions of various magnitudes and time scales that are involved in the function of this important class of membrane proteins.

  18. Laser Controlled Molecular Orientation Dynamics

    International Nuclear Information System (INIS)

    Atabek, O.

    2004-01-01

    Molecular orientation is a challenging control issue covering a wide range of applications from reactive collisions, high order harmonic generation, surface processing and catalysis, to nanotechnologies. The laser control scenario rests on the following three steps: (i) depict some basic mechanisms producing dynamical orientation; (ii) use them both as computational and interpretative tools in optimal control schemes involving genetic algorithms; (iii) apply what is learnt from optimal control to improve the basic mechanisms. The existence of a target molecular rotational state combining the advantages of efficient and post-pulse long duration orientation is shown. A strategy is developed for reaching such a target in terms of a train of successive short laser pulses applied at predicted time intervals. Each individual pulse imparts a kick to the molecule which orients. Transposition of such strategies to generic systems is now under investigation

  19. Molecular potentials and relaxation dynamics

    International Nuclear Information System (INIS)

    Karo, A.M.

    1981-01-01

    The use of empirical pseudopotentials, in evaluating interatomic potentials, provides an inexpensive and convenient method for obtaining highly accurate potential curves and permits the modeling of core-valence correlation, and the inclusion of relativistic effects when these are significant. Recent calculations of the X 1 Σ + and a 3 Σ + states of LiH, NaH, KH, RbH, and CsH and the X 2 Σ + states of their anions are discussed. Pseudopotentials, including core polarization terms, have been used to replace the core electrons, and this has been coupled with the development of compact, higly-optimized basis sets for the corresponding one- and two-electron atoms. Comparisons of the neutral potential curves with experiment and other ab initio calculations show good agreement (within 1000 cm -1 over most of the potential curves) with the difference curves being considerably more accurate. In the method of computer molecular dynamics, the force acting on each particle is the resultant of all interactions with other atoms in the neighborhood and is obtained as the derivative of an effective many-body potential. Exploiting the pseudopotential approach, in obtaining the appropriate potentials may be very fruitful in the future. In the molecular dynamics example considered here, the conventional sum-of-pairwise-interatomic-potentials (SPP) approximation is used with the potentials derived either from experimental spectroscopic data or from Hartree-Fock calculations. The problem is the collisional de-excitation of vibrationally excited molecular hydrogen at an Fe surface. The calculations have been carried out for an initial vibrotational state v = 8, J = 1 and a translational temperature corresponding to a gas temperature of 500 0 K. Different angles of approach and different initial random impact points on the surface have been selected. For any given collision with the wall, the molecule may pick up or lose vibrotatonal and translational energy

  20. Molecular dynamics simulations of solutions at constant chemical potential

    Science.gov (United States)

    Perego, C.; Salvalaglio, M.; Parrinello, M.

    2015-04-01

    Molecular dynamics studies of chemical processes in solution are of great value in a wide spectrum of applications, which range from nano-technology to pharmaceutical chemistry. However, these calculations are affected by severe finite-size effects, such as the solution being depleted as the chemical process proceeds, which influence the outcome of the simulations. To overcome these limitations, one must allow the system to exchange molecules with a macroscopic reservoir, thus sampling a grand-canonical ensemble. Despite the fact that different remedies have been proposed, this still represents a key challenge in molecular simulations. In the present work, we propose the Constant Chemical Potential Molecular Dynamics (CμMD) method, which introduces an external force that controls the environment of the chemical process of interest. This external force, drawing molecules from a finite reservoir, maintains the chemical potential constant in the region where the process takes place. We have applied the CμMD method to the paradigmatic case of urea crystallization in aqueous solution. As a result, we have been able to study crystal growth dynamics under constant supersaturation conditions and to extract growth rates and free-energy barriers.

  1. The 2011 Dynamics of Molecular Collisions Conference

    Energy Technology Data Exchange (ETDEWEB)

    Nesbitt, David J. [JILA, NIST

    2011-07-11

    The Dynamics of Molecular Collisions Conference focuses on all aspects of molecular collisions--experimental & theoretical studies of elastic, inelastic, & reactive encounters involving atoms, molecules, ions, clusters, & surfaces--as well as half collisions--photodissociation, photo-induced reaction, & photodesorption. The scientific program for the meeting in 2011 included exciting advances in both the core & multidisciplinary forefronts of the study of molecular collision processes. Following the format of the 2009 meeting, we also invited sessions in special topics that involve interfacial dynamics, novel emerging spectroscopies, chemical dynamics in atmospheric, combustion & interstellar environments, as well as a session devoted to theoretical & experimental advances in ultracold molecular samples. Researchers working inside & outside the traditional core topics of the meeting are encouraged to join the conference. We invite contributions of work that seeks understanding of how inter & intra-molecular forces determine the dynamics of the phenomena under study. In addition to invited oral sessions & contributed poster sessions, the scientific program included a formal session consisting of five contributed talks selected from the submitted poster abstracts. The DMC has distinguished itself by having the Herschbach Medal Symposium as part of the meeting format. This tradition of the Herschbach Medal was first started in the 2007 meeting chaired by David Chandler, based on a generous donation of funds & artwork design by Professor Dudley Herschbach himself. There are two such awards made, one for experimental & one for theoretical contributions to the field of Molecular Collision Dynamics, broadly defined. The symposium is always held on the last night of the meeting & has the awardees are asked to deliver an invited lecture on their work. The 2011 Herschbach Medal was dedicated to the contributions of two long standing leaders in Chemical Physics, Professor

  2. Scalable synthesis of sequence-defined, unimolecular macromolecules by Flow-IEG

    Science.gov (United States)

    Leibfarth, Frank A.; Johnson, Jeremiah A.; Jamison, Timothy F.

    2015-01-01

    We report a semiautomated synthesis of sequence and architecturally defined, unimolecular macromolecules through a marriage of multistep flow synthesis and iterative exponential growth (Flow-IEG). The Flow-IEG system performs three reactions and an in-line purification in a total residence time of under 10 min, effectively doubling the molecular weight of an oligomeric species in an uninterrupted reaction sequence. Further iterations using the Flow-IEG system enable an exponential increase in molecular weight. Incorporating a variety of monomer structures and branching units provides control over polymer sequence and architecture. The synthesis of a uniform macromolecule with a molecular weight of 4,023 g/mol is demonstrated. The user-friendly nature, scalability, and modularity of Flow-IEG provide a general strategy for the automated synthesis of sequence-defined, unimolecular macromolecules. Flow-IEG is thus an enabling tool for theory validation, structure–property studies, and advanced applications in biotechnology and materials science. PMID:26269573

  3. Towards the molecular bases of polymerase dynamics

    International Nuclear Information System (INIS)

    Chela Flores, J.

    1991-03-01

    One aspect of the strong relationship that is known to exist between the processes of DNA replication and transcription is manifest in the coupling of the rates of movement of the replication fork (r f ) and RNA polymerase (r t ). We address two issues concerning the largely unexplored area of polymerase dynamics: (i) The validity of an approximate kinematic formula linking r f and r t suggested by experiments in which transcription is initiated in some prokaryotes with the antibiotic streptolydigin, and (ii) What are the molecular bases of the kinematic formula? An analysis of the available data suggests possible molecular bases for polymerase dynamics. In particular, we are led to a hypothesis: In active chromatin r t may depend on the length (λ t ) of the transcript of the primary messenger RNA (pre-mRNA). This new effect is subject to experimental verification. We discuss possible experiments that may be performed in order to test this prediction. (author). Refs, 6 tabs

  4. Dynamical quenching of tunneling in molecular magnets

    International Nuclear Information System (INIS)

    José Santander, María; Nunez, Alvaro S.; Roldán-Molina, A.; Troncoso, Roberto E.

    2015-01-01

    It is shown that a single molecular magnet placed in a rapidly oscillating magnetic field displays the phenomenon of quenching of tunneling processes. The results open a way to manipulate the quantum states of molecular magnets by means of radiation in the terahertz range. Our analysis separates the time evolution into slow and fast components thereby obtaining an effective theory for the slow dynamics. This effective theory presents quenching of the tunnel effect, in particular, stands out its difference with the so-called coherent destruction of tunneling. We support our prediction with numerical evidence based on an exact solution of Schrödinger's equation. - Highlights: • Single molecular magnets under rapidly oscillating magnetic fields is studied. • It is shown that this system displays the quenching of tunneling processes. • Our findings provide a control of quantum molecular magnets via terahertz radiation

  5. Dynamical quenching of tunneling in molecular magnets

    Energy Technology Data Exchange (ETDEWEB)

    José Santander, María, E-mail: maria.jose.noemi@gmail.com [Recursos Educativos Quántica, Santiago (Chile); Departamento de Física, Universidad de Santiago de Chile and CEDENNA, Avda. Ecuador 3493, Santiago (Chile); Nunez, Alvaro S., E-mail: alnunez@dfi.uchile.cl [Departamento de Física, Facultad de Ciencias Físicas y Matemáticas, Universidad de Chile, Casilla 487-3, Santiago (Chile); Roldán-Molina, A. [Instituto de Física, Pontificia Universidad Católica de Valparaíso, Avenida Universidad 330, Curauma, Valparaíso (Chile); Troncoso, Roberto E., E-mail: r.troncoso.c@gmail.com [Centro para el Desarrollo de la Nanociencia y la Nanotecnología, CEDENNA, Avda. Ecuador 3493, Santiago 9170124 (Chile); Departamento de Física, Universidad Técnica Federico Santa María, Avenida España 1680, Valparaíso (Chile)

    2015-12-15

    It is shown that a single molecular magnet placed in a rapidly oscillating magnetic field displays the phenomenon of quenching of tunneling processes. The results open a way to manipulate the quantum states of molecular magnets by means of radiation in the terahertz range. Our analysis separates the time evolution into slow and fast components thereby obtaining an effective theory for the slow dynamics. This effective theory presents quenching of the tunnel effect, in particular, stands out its difference with the so-called coherent destruction of tunneling. We support our prediction with numerical evidence based on an exact solution of Schrödinger's equation. - Highlights: • Single molecular magnets under rapidly oscillating magnetic fields is studied. • It is shown that this system displays the quenching of tunneling processes. • Our findings provide a control of quantum molecular magnets via terahertz radiation.

  6. ESVD: An Integrated Energy Scalable Framework for Low-Power Video Decoding Systems

    Directory of Open Access Journals (Sweden)

    Wen Ji

    2010-01-01

    Full Text Available Video applications using mobile wireless devices are a challenging task due to the limited capacity of batteries. The higher complex functionality of video decoding needs high resource requirements. Thus, power efficient control has become more critical design with devices integrating complex video processing techniques. Previous works on power efficient control in video decoding systems often aim at the low complexity design and not explicitly consider the scalable impact of subfunctions in decoding process, and seldom consider the relationship with the features of compressed video date. This paper is dedicated to developing an energy-scalable video decoding (ESVD strategy for energy-limited mobile terminals. First, ESVE can dynamically adapt the variable energy resources due to the device aware technique. Second, ESVD combines the decoder control with decoded data, through classifying the data into different partition profiles according to its characteristics. Third, it introduces utility theoretical analysis during the resource allocation process, so as to maximize the resource utilization. Finally, it adapts the energy resource as different energy budget and generates the scalable video decoding output under energy-limited systems. Experimental results demonstrate the efficiency of the proposed approach.

  7. A stochastic phase-field model determined from molecular dynamics

    KAUST Repository

    von Schwerin, Erik

    2010-03-17

    The dynamics of dendritic growth of a crystal in an undercooled melt is determined by macroscopic diffusion-convection of heat and by capillary forces acting on the nanometer scale of the solid-liquid interface width. Its modelling is useful for instance in processing techniques based on casting. The phase-field method is widely used to study evolution of such microstructural phase transformations on a continuum level; it couples the energy equation to a phenomenological Allen-Cahn/Ginzburg-Landau equation modelling the dynamics of an order parameter determining the solid and liquid phases, including also stochastic fluctuations to obtain the qualitatively correct result of dendritic side branching. This work presents a method to determine stochastic phase-field models from atomistic formulations by coarse-graining molecular dynamics. It has three steps: (1) a precise quantitative atomistic definition of the phase-field variable, based on the local potential energy; (2) derivation of its coarse-grained dynamics model, from microscopic Smoluchowski molecular dynamics (that is Brownian or over damped Langevin dynamics); and (3) numerical computation of the coarse-grained model functions. The coarse-grained model approximates Gibbs ensemble averages of the atomistic phase-field, by choosing coarse-grained drift and diffusion functions that minimize the approximation error of observables in this ensemble average. © EDP Sciences, SMAI, 2010.

  8. A stochastic phase-field model determined from molecular dynamics

    KAUST Repository

    von Schwerin, Erik; Szepessy, Anders

    2010-01-01

    The dynamics of dendritic growth of a crystal in an undercooled melt is determined by macroscopic diffusion-convection of heat and by capillary forces acting on the nanometer scale of the solid-liquid interface width. Its modelling is useful for instance in processing techniques based on casting. The phase-field method is widely used to study evolution of such microstructural phase transformations on a continuum level; it couples the energy equation to a phenomenological Allen-Cahn/Ginzburg-Landau equation modelling the dynamics of an order parameter determining the solid and liquid phases, including also stochastic fluctuations to obtain the qualitatively correct result of dendritic side branching. This work presents a method to determine stochastic phase-field models from atomistic formulations by coarse-graining molecular dynamics. It has three steps: (1) a precise quantitative atomistic definition of the phase-field variable, based on the local potential energy; (2) derivation of its coarse-grained dynamics model, from microscopic Smoluchowski molecular dynamics (that is Brownian or over damped Langevin dynamics); and (3) numerical computation of the coarse-grained model functions. The coarse-grained model approximates Gibbs ensemble averages of the atomistic phase-field, by choosing coarse-grained drift and diffusion functions that minimize the approximation error of observables in this ensemble average. © EDP Sciences, SMAI, 2010.

  9. Nanopore wall-liquid interaction under scope of molecular dynamics study: Review

    Science.gov (United States)

    Tsukanov, A. A.; Psakhie, S. G.

    2017-12-01

    The present review is devoted to the analysis of recent molecular dynamics based on the numerical studies of molecular aspects of solid-fluid interaction in nanoscale channels. Nanopore wall-liquid interaction plays the crucial role in such processes as gas separation, water desalination, liquids decontamination, hydrocarbons and water transport in nano-fractured geological formations. Molecular dynamics simulation is one of the most suitable tools to study molecular level effects occurred in such multicomponent systems. The nanopores are classified by their geometry to four groups: nanopore in nanosheet, nanotube-like pore, slit-shaped nanopore and soft-matter nanopore. The review is focused on the functionalized nanopores in boron nitride nanosheets as novel selective membranes and on the slit-shaped nanopores formed by minerals.

  10. Development, Verification and Validation of Parallel, Scalable Volume of Fluid CFD Program for Propulsion Applications

    Science.gov (United States)

    West, Jeff; Yang, H. Q.

    2014-01-01

    There are many instances involving liquid/gas interfaces and their dynamics in the design of liquid engine powered rockets such as the Space Launch System (SLS). Some examples of these applications are: Propellant tank draining and slosh, subcritical condition injector analysis for gas generators, preburners and thrust chambers, water deluge mitigation for launch induced environments and even solid rocket motor liquid slag dynamics. Commercially available CFD programs simulating gas/liquid interfaces using the Volume of Fluid approach are currently limited in their parallel scalability. In 2010 for instance, an internal NASA/MSFC review of three commercial tools revealed that parallel scalability was seriously compromised at 8 cpus and no additional speedup was possible after 32 cpus. Other non-interface CFD applications at the time were demonstrating useful parallel scalability up to 4,096 processors or more. Based on this review, NASA/MSFC initiated an effort to implement a Volume of Fluid implementation within the unstructured mesh, pressure-based algorithm CFD program, Loci-STREAM. After verification was achieved by comparing results to the commercial CFD program CFD-Ace+, and validation by direct comparison with data, Loci-STREAM-VoF is now the production CFD tool for propellant slosh force and slosh damping rate simulations at NASA/MSFC. On these applications, good parallel scalability has been demonstrated for problems sizes of tens of millions of cells and thousands of cpu cores. Ongoing efforts are focused on the application of Loci-STREAM-VoF to predict the transient flow patterns of water on the SLS Mobile Launch Platform in order to support the phasing of water for launch environment mitigation so that vehicle determinantal effects are not realized.

  11. Silicon nanophotonics for scalable quantum coherent feedback networks

    International Nuclear Information System (INIS)

    Sarovar, Mohan; Brif, Constantin; Soh, Daniel B.S.; Cox, Jonathan; DeRose, Christopher T.; Camacho, Ryan; Davids, Paul

    2016-01-01

    The emergence of coherent quantum feedback control (CQFC) as a new paradigm for precise manipulation of dynamics of complex quantum systems has led to the development of efficient theoretical modeling and simulation tools and opened avenues for new practical implementations. This work explores the applicability of the integrated silicon photonics platform for implementing scalable CQFC networks. If proven successful, on-chip implementations of these networks would provide scalable and efficient nanophotonic components for autonomous quantum information processing devices and ultra-low-power optical processing systems at telecommunications wavelengths. We analyze the strengths of the silicon photonics platform for CQFC applications and identify the key challenges to both the theoretical formalism and experimental implementations. In particular, we determine specific extensions to the theoretical CQFC framework (which was originally developed with bulk-optics implementations in mind), required to make it fully applicable to modeling of linear and nonlinear integrated optics networks. We also report the results of a preliminary experiment that studied the performance of an in situ controllable silicon nanophotonic network of two coupled cavities and analyze the properties of this device using the CQFC formalism. (orig.)

  12. Silicon nanophotonics for scalable quantum coherent feedback networks

    Energy Technology Data Exchange (ETDEWEB)

    Sarovar, Mohan; Brif, Constantin [Sandia National Laboratories, Livermore, CA (United States); Soh, Daniel B.S. [Sandia National Laboratories, Livermore, CA (United States); Stanford University, Edward L. Ginzton Laboratory, Stanford, CA (United States); Cox, Jonathan; DeRose, Christopher T.; Camacho, Ryan; Davids, Paul [Sandia National Laboratories, Albuquerque, NM (United States)

    2016-12-15

    The emergence of coherent quantum feedback control (CQFC) as a new paradigm for precise manipulation of dynamics of complex quantum systems has led to the development of efficient theoretical modeling and simulation tools and opened avenues for new practical implementations. This work explores the applicability of the integrated silicon photonics platform for implementing scalable CQFC networks. If proven successful, on-chip implementations of these networks would provide scalable and efficient nanophotonic components for autonomous quantum information processing devices and ultra-low-power optical processing systems at telecommunications wavelengths. We analyze the strengths of the silicon photonics platform for CQFC applications and identify the key challenges to both the theoretical formalism and experimental implementations. In particular, we determine specific extensions to the theoretical CQFC framework (which was originally developed with bulk-optics implementations in mind), required to make it fully applicable to modeling of linear and nonlinear integrated optics networks. We also report the results of a preliminary experiment that studied the performance of an in situ controllable silicon nanophotonic network of two coupled cavities and analyze the properties of this device using the CQFC formalism. (orig.)

  13. Field theoretic approach to dynamical orbital localization in ab initio molecular dynamics

    International Nuclear Information System (INIS)

    Thomas, Jordan W.; Iftimie, Radu; Tuckerman, Mark E.

    2004-01-01

    Techniques from gauge-field theory are employed to derive an alternative formulation of the Car-Parrinello ab initio molecular-dynamics method that allows maximally localized Wannier orbitals to be generated dynamically as the calculation proceeds. In particular, the Car-Parrinello Lagrangian is mapped onto an SU(n) non-Abelian gauge-field theory and the fictitious kinetic energy in the Car-Parrinello Lagrangian is modified to yield a fully gauge-invariant form. The Dirac gauge-fixing method is then employed to derive a set of equations of motion that automatically maintain orbital locality by restricting the orbitals to remain in the 'Wannier gauge'. An approximate algorithm for integrating the equations of motion that is stable and maintains orbital locality is then developed based on the exact equations of motion. It is shown in a realistic application (64 water molecules plus one hydrogen-chloride molecule in a periodic box) that orbital locality can be maintained with only a modest increase in CPU time. The ability to keep orbitals localized in an ab initio molecular-dynamics calculation is a crucial ingredient in the development of emerging linear scaling approaches

  14. Scalable algorithms for contact problems

    CERN Document Server

    Dostál, Zdeněk; Sadowská, Marie; Vondrák, Vít

    2016-01-01

    This book presents a comprehensive and self-contained treatment of the authors’ newly developed scalable algorithms for the solutions of multibody contact problems of linear elasticity. The brand new feature of these algorithms is theoretically supported numerical scalability and parallel scalability demonstrated on problems discretized by billions of degrees of freedom. The theory supports solving multibody frictionless contact problems, contact problems with possibly orthotropic Tresca’s friction, and transient contact problems. It covers BEM discretization, jumping coefficients, floating bodies, mortar non-penetration conditions, etc. The exposition is divided into four parts, the first of which reviews appropriate facets of linear algebra, optimization, and analysis. The most important algorithms and optimality results are presented in the third part of the volume. The presentation is complete, including continuous formulation, discretization, decomposition, optimality results, and numerical experimen...

  15. The use of molecular dynamics for the thermodynamic properties of simple and transition metals

    International Nuclear Information System (INIS)

    Straub, G.K.

    1987-04-01

    The technique of computer simulation of the molecular dynamics in metallic systems to calculate thermodynamic properties is discussed. The nature of a metal as determined by its electronic structure is used to determine the total adiabatic potential. The effective screened ion-ion interaction can then be used in a molecular dynamics simulation. The method for the construction of a molecular dynamics ensemble, its relation to the canonical ensemble, and the definition of thermodynamic functions from the Helmholtz free energy is given. The method for the analysis of the molecular dynamics results from quasiharmonic lattice dynamics and the decomposition in terms of harmonic and anharmonic contributions is given for solids. For fluid phase metals, procedures for calculating the thermodynamics and determining the constant of entropy are presented. The solid-fluid phase boundary as a function of pressure and temperature is determined using the results of molecular dynamics. Throughout, examples and results for metallic sodium are used. The treatment of the transition metal electronic d-states in terms of an effective pair-wise interaction is also discussed and the phonon dispersion curves of Al, Ni, and Cu are calculated

  16. Extended Lagrangian Born-Oppenheimer molecular dynamics simulations of the shock-induced chemistry of phenylacetylene

    Energy Technology Data Exchange (ETDEWEB)

    Cawkwell, M. J., E-mail: cawkwell@lanl.gov; Niklasson, Anders M. N. [Theoretical Division, Los Alamos National Laboratory, Los Alamos, New Mexico 87545 (United States); Dattelbaum, Dana M. [Weapons Experiments Division, Los Alamos National Laboratory, Los Alamos, New Mexico 87545 (United States)

    2015-02-14

    The initial chemical events that occur during the shock compression of liquid phenylacetylene have been investigated using self-consistent tight binding molecular dynamics simulations. The extended Lagrangian Born-Oppenheimer molecular dynamics formalism enabled us to compute microcanonical trajectories with precise conservation of the total energy. Our simulations revealed that the first density-increasing step under shock compression arises from the polymerization of phenylacetylene molecules at the acetylene moiety. The application of electronic structure-based molecular dynamics with long-term conservation of the total energy enabled us to identify electronic signatures of reactivity via monitoring changes in the HOMO-LUMO gap, and to capture directly adiabatic shock heating, transient non-equilibrium states, and changes in temperature arising from exothermic chemistry in classical molecular dynamics trajectories.

  17. Extended Lagrangian Born-Oppenheimer molecular dynamics simulations of the shock-induced chemistry of phenylacetylene.

    Science.gov (United States)

    Cawkwell, M J; Niklasson, Anders M N; Dattelbaum, Dana M

    2015-02-14

    The initial chemical events that occur during the shock compression of liquid phenylacetylene have been investigated using self-consistent tight binding molecular dynamics simulations. The extended Lagrangian Born-Oppenheimer molecular dynamics formalism enabled us to compute microcanonical trajectories with precise conservation of the total energy. Our simulations revealed that the first density-increasing step under shock compression arises from the polymerization of phenylacetylene molecules at the acetylene moiety. The application of electronic structure-based molecular dynamics with long-term conservation of the total energy enabled us to identify electronic signatures of reactivity via monitoring changes in the HOMO-LUMO gap, and to capture directly adiabatic shock heating, transient non-equilibrium states, and changes in temperature arising from exothermic chemistry in classical molecular dynamics trajectories.

  18. A MOLECULAR-DYNAMICS STUDY OF LECITHIN MONOLAYERS

    NARCIS (Netherlands)

    AHLSTROM, P; BERENDSEN, HJC

    1993-01-01

    Two monolayers of didecanoyllecithin at the air-water interface have been studied using molecular dynamics simulations. The model system consisted of two monolayers of 42 lecithin molecules each separated by a roughly 4 nm thick slab of SPC water. The area per lecithin molecule was 0.78 nm(2)

  19. Correlations and symmetry of interactions influence collective dynamics of molecular motors

    International Nuclear Information System (INIS)

    Celis-Garza, Daniel; Teimouri, Hamid; Kolomeisky, Anatoly B

    2015-01-01

    Enzymatic molecules that actively support many cellular processes, including transport, cell division and cell motility, are known as motor proteins or molecular motors. Experimental studies indicate that they interact with each other and they frequently work together in large groups. To understand the mechanisms of collective behavior of motor proteins we study the effect of interactions in the transport of molecular motors along linear filaments. It is done by analyzing a recently introduced class of totally asymmetric exclusion processes that takes into account the intermolecular interactions via thermodynamically consistent approach. We develop a new theoretical method that allows us to compute analytically all dynamic properties of the system. Our analysis shows that correlations play important role in dynamics of interacting molecular motors. Surprisingly, we find that the correlations for repulsive interactions are weaker and more short-range than the correlations for the attractive interactions. In addition, it is shown that symmetry of interactions affect dynamic properties of molecular motors. The implications of these findings for motor proteins transport are discussed. Our theoretical predictions are tested by extensive Monte Carlo computer simulations. (paper)

  20. Molecular dynamics simulation of impact test

    International Nuclear Information System (INIS)

    Akahoshi, Y.; Schmauder, S.; Ludwig, M.

    1998-01-01

    This paper describes an impact test by molecular dynamics (MD) simulation to evaluate embrittlement of bcc Fe at different temperatures. A new impact test model is developed for MD simulation. The typical fracture behaviors show transition from brittle to ductile fracture, and a history of the impact loads also demonstrates its transition. We conclude that the impact test by MD could be feasible. (orig.)

  1. Molecular dynamics simulation of impact test

    Energy Technology Data Exchange (ETDEWEB)

    Akahoshi, Y. [Kyushu Inst. of Tech., Kitakyushu, Fukuoka (Japan); Schmauder, S.; Ludwig, M. [Stuttgart Univ. (Germany). Staatliche Materialpruefungsanstalt

    1998-11-01

    This paper describes an impact test by molecular dynamics (MD) simulation to evaluate embrittlement of bcc Fe at different temperatures. A new impact test model is developed for MD simulation. The typical fracture behaviors show transition from brittle to ductile fracture, and a history of the impact loads also demonstrates its transition. We conclude that the impact test by MD could be feasible. (orig.)

  2. Molecular Dynamics Simulations of a Linear Nanomotor Driven by Thermophoretic Forces

    DEFF Research Database (Denmark)

    Zambrano, Harvey A; Walther, Jens Honore; Jaffe, Richard L.

    Molecular Dynamics of a Linear Nanomotor Driven by Thermophoresis Harvey A. Zambrano1, Jens H. Walther1,2 and Richard L. Jaffe3 1Department of Mechanical Engineering, Fluid Mechanics, Technical University of Denmark, DK-2800 Lyngby, Denmark; 2Computational Science and Engineering Laboratory, ETH...... future molecular machines a complete understanding of the friction forces involved on the transport process at the molecular level have to be addressed.18 In this work we perform Molecular Dynamics (MD) simulations using the MD package FASTTUBE19 to study a molecular linear motor consisting of coaxial...... the valence forces within the CNT using Morse, harmonic angle and torsion potentials.19We include a nonbonded carbon-carbon Lennard-Jones potential to describe the vdW interaction between the carbon atoms within the double wall portion of the system. We equilibrate the system at 300K for 0.1 ns, by coupling...

  3. Combined Molecular Dynamics Simulation-Molecular-Thermodynamic Theory Framework for Predicting Surface Tensions.

    Science.gov (United States)

    Sresht, Vishnu; Lewandowski, Eric P; Blankschtein, Daniel; Jusufi, Arben

    2017-08-22

    A molecular modeling approach is presented with a focus on quantitative predictions of the surface tension of aqueous surfactant solutions. The approach combines classical Molecular Dynamics (MD) simulations with a molecular-thermodynamic theory (MTT) [ Y. J. Nikas, S. Puvvada, D. Blankschtein, Langmuir 1992 , 8 , 2680 ]. The MD component is used to calculate thermodynamic and molecular parameters that are needed in the MTT model to determine the surface tension isotherm. The MD/MTT approach provides the important link between the surfactant bulk concentration, the experimental control parameter, and the surfactant surface concentration, the MD control parameter. We demonstrate the capability of the MD/MTT modeling approach on nonionic alkyl polyethylene glycol surfactants at the air-water interface and observe reasonable agreement of the predicted surface tensions and the experimental surface tension data over a wide range of surfactant concentrations below the critical micelle concentration. Our modeling approach can be extended to ionic surfactants and their mixtures with both ionic and nonionic surfactants at liquid-liquid interfaces.

  4. Molecular dynamics simulation of a phospholipid membrane

    NARCIS (Netherlands)

    Egberts, Egbert; Marrink, Siewert-Jan; Berendsen, Herman J.C.

    We present the results of molecular dynamics (MD) simulations of a phospholipid membrane in water, including full atomic detail. The goal of the simulations was twofold: first we wanted to set up a simulation system which is able to reproduce experimental results and can serve as a model membrane in

  5. Structural, dynamic, and vibrational properties during heat transfer in Si/Ge superlattices: A Car-Parrinello molecular dynamics study

    Energy Technology Data Exchange (ETDEWEB)

    Ji, Pengfei; Zhang, Yuwen, E-mail: zhangyu@missouri.edu [Department of Mechanical and Aerospace Engineering, University of Missouri, Columbia, Missouri 65211 (United States); Yang, Mo [College of Energy and Power Engineering, University of Shanghai for Science and Technology, Shanghai 200093 (China)

    2013-12-21

    The structural, dynamic, and vibrational properties during heat transfer process in Si/Ge superlattices are studied by analyzing the trajectories generated by the ab initio Car-Parrinello molecular dynamics simulation. The radial distribution functions and mean square displacements are calculated and further discussions are made to explain and probe the structural changes relating to the heat transfer phenomenon. Furthermore, the vibrational density of states of the two layers (Si/Ge) are computed and plotted to analyze the contributions of phonons with different frequencies to the heat conduction. Coherent heat conduction of the low frequency phonons is found and their contributions to facilitate heat transfer are confirmed. The Car-Parrinello molecular dynamics simulation outputs in the work show reasonable thermophysical results of the thermal energy transport process and shed light on the potential applications of treating the heat transfer in the superlattices of semiconductor materials from a quantum mechanical molecular dynamics simulation perspective.

  6. Structural, dynamic, and vibrational properties during heat transfer in Si/Ge superlattices: A Car-Parrinello molecular dynamics study

    International Nuclear Information System (INIS)

    Ji, Pengfei; Zhang, Yuwen; Yang, Mo

    2013-01-01

    The structural, dynamic, and vibrational properties during heat transfer process in Si/Ge superlattices are studied by analyzing the trajectories generated by the ab initio Car-Parrinello molecular dynamics simulation. The radial distribution functions and mean square displacements are calculated and further discussions are made to explain and probe the structural changes relating to the heat transfer phenomenon. Furthermore, the vibrational density of states of the two layers (Si/Ge) are computed and plotted to analyze the contributions of phonons with different frequencies to the heat conduction. Coherent heat conduction of the low frequency phonons is found and their contributions to facilitate heat transfer are confirmed. The Car-Parrinello molecular dynamics simulation outputs in the work show reasonable thermophysical results of the thermal energy transport process and shed light on the potential applications of treating the heat transfer in the superlattices of semiconductor materials from a quantum mechanical molecular dynamics simulation perspective

  7. Structural, dynamic, and vibrational properties during heat transfer in Si/Ge superlattices: A Car-Parrinello molecular dynamics study

    Science.gov (United States)

    Ji, Pengfei; Zhang, Yuwen; Yang, Mo

    2013-12-01

    The structural, dynamic, and vibrational properties during heat transfer process in Si/Ge superlattices are studied by analyzing the trajectories generated by the ab initio Car-Parrinello molecular dynamics simulation. The radial distribution functions and mean square displacements are calculated and further discussions are made to explain and probe the structural changes relating to the heat transfer phenomenon. Furthermore, the vibrational density of states of the two layers (Si/Ge) are computed and plotted to analyze the contributions of phonons with different frequencies to the heat conduction. Coherent heat conduction of the low frequency phonons is found and their contributions to facilitate heat transfer are confirmed. The Car-Parrinello molecular dynamics simulation outputs in the work show reasonable thermophysical results of the thermal energy transport process and shed light on the potential applications of treating the heat transfer in the superlattices of semiconductor materials from a quantum mechanical molecular dynamics simulation perspective.

  8. Shapiro like steps reveals molecular nanomagnets’ spin dynamics

    International Nuclear Information System (INIS)

    Abdollahipour, Babak; Abouie, Jahanfar; Ebrahimi, Navid

    2015-01-01

    We present an accurate way to detect spin dynamics of a nutating molecular nanomagnet by inserting it in a tunnel Josephson junction and studying the current voltage (I-V) characteristic. The spin nutation of the molecular nanomagnet is generated by applying two circularly polarized magnetic fields. We demonstrate that modulation of the Josephson current by the nutation of the molecular nanomagnet’s spin appears as a stepwise structure like Shapiro steps in the I-V characteristic of the junction. Width and heights of these Shapiro-like steps are determined by two parameters of the spin nutation, frequency and amplitude of the nutation, which are simply tuned by the applied magnetic fields

  9. Multiscale Modeling of Complex Molecular Structure and Dynamics with MBN Explorer

    DEFF Research Database (Denmark)

    Solov'yov, Ilia A.; Korol, Andrei V.; Solov'yov, Andrey V.

    -up of input files, controls the simulations, and supports the subsequent visualization and analysis of the results obtained. The book subsequently provides a systematic description of the capabilities of this universal and powerful software package within the framework of computational molecular science...... of molecular and random walk dynamics. The package allows the use of a broad variety of interatomic potentials and can, e.g., be configured to select any subset of a molecular system as rigid fragments, whenever a significant reduction in the number of dynamical degrees of freedom is required for computational...... practicalities. MBN Studio enables users to easily construct initial geometries for the molecular, liquid, crystalline, gaseous and hybrid systems that serve as input for the subsequent simulations of their physical and chemical properties using MBN Explorer. Despite its universality, the computational...

  10. Extended Lagrangian formulation of charge-constrained tight-binding molecular dynamics.

    Science.gov (United States)

    Cawkwell, M J; Coe, J D; Yadav, S K; Liu, X-Y; Niklasson, A M N

    2015-06-09

    The extended Lagrangian Born-Oppenheimer molecular dynamics formalism [Niklasson, Phys. Rev. Lett., 2008, 100, 123004] has been applied to a tight-binding model under the constraint of local charge neutrality to yield microcanonical trajectories with both precise, long-term energy conservation and a reduced number of self-consistent field optimizations at each time step. The extended Lagrangian molecular dynamics formalism restores time reversal symmetry in the propagation of the electronic degrees of freedom, and it enables the efficient and accurate self-consistent optimization of the chemical potential and atomwise potential energy shifts in the on-site elements of the tight-binding Hamiltonian that are required when enforcing local charge neutrality. These capabilities are illustrated with microcanonical molecular dynamics simulations of a small metallic cluster using an sd-valent tight-binding model for titanium. The effects of weak dissipation on the propagation of the auxiliary degrees of freedom for the chemical potential and on-site Hamiltonian matrix elements that is used to counteract the accumulation of numerical noise during trajectories was also investigated.

  11. Electron-nuclear corellations for photoinduced dynamics in molecular dimers

    Science.gov (United States)

    Kilin, Dmitri S.; Pereversev, Yuryi V.; Prezhdo, Oleg V.

    2003-03-01

    Ultrafast photoinduced dynamics of electronic excitation in molecular dimers is drastically affected by dynamic reorganization of of inter- and intra- molecular nuclear configuration modelled by quantized nuclear degree of freedom [1]. The dynamics of the electronic population and nuclear coherence is analyzed with help of both numerical solution of the chain of coupled differential equations for mean coordinate, population inversion, electronic-vibrational correlation etc.[2] and by propagating the Gaussian wavepackets in relevant adiabatic potentials. Intriguing results were obtained in the approximation of small energy difference and small change of nuclear equilibrium configuration for excited electronic states. In the limiting case of resonance between electronic states energy difference and frequency of the nuclear mode these results have been justified by comparison to exactly solvable Jaynes-Cummings model. It has been found that the photoinduced processes in dimer are arranged according to their time scales:(i) fast scale of nuclear motion,(ii) intermediate scale of dynamical redistribution of electronic population between excited states as well as growth and dynamics of electronic -nuclear correlation,(iii) slow scale of electronic population approaching to the quasiequilibrium distribution, decay of electronic-nuclear correlation, and diminishing the amplitude of mean coordinate oscillations, accompanied by essential growth of the nuclear coordinate dispersion associated with the overall nuclear wavepacket width. Demonstrated quantum-relaxational features of photoinduced vibronic dinamical processess in molecular dimers are obtained by simple method, applicable to large biological systems with many degrees of freedom. [1] J. A. Cina, D. S. Kilin, T. S. Humble, J. Chem. Phys. (2003) in press. [2] O. V. Prezhdo, J. Chem. Phys. 117, 2995 (2002).

  12. Scalable Security and Accounting Services for Content-Based Publish/Subscribe Systems

    OpenAIRE

    Himanshu Khurana; Radostina K. Koleva

    2006-01-01

    Content-based publish/subscribe systems offer an interaction scheme that is appropriate for a variety of large-scale dynamic applications. However, widespread use of these systems is hindered by a lack of suitable security services. In this paper, we present scalable solutions for confidentiality, integrity, and authentication for these systems. We also provide verifiable usage-based accounting services, which are required for e-commerce and e-business applications that use publish/subscribe ...

  13. Vectorization, parallelization and implementation of Quantum molecular dynamics codes (QQQF, MONTEV)

    Energy Technology Data Exchange (ETDEWEB)

    Kato, Kaori [High Energy Accelerator Research Organization, Tsukuba, Ibaraki (Japan); Kunugi, Tomoaki; Kotake, Susumu; Shibahara, Masahiko

    1998-03-01

    This report describes parallelization, vectorization and implementation for two simulation codes, Quantum molecular dynamics simulation code QQQF and Photon montecalro molecular dynamics simulation code MONTEV, that have been developed for the analysis of the thermalization of photon energies in the molecule or materials. QQQF has been vectorized and parallelized on Fujitsu VPP and has been implemented from VPP to Intel Paragon XP/S and parallelized. MONTEV has been implemented from VPP to Paragon and parallelized. (author)

  14. Quantum wavepacket ab initio molecular dynamics: an approach for computing dynamically averaged vibrational spectra including critical nuclear quantum effects.

    Science.gov (United States)

    Sumner, Isaiah; Iyengar, Srinivasan S

    2007-10-18

    We have introduced a computational methodology to study vibrational spectroscopy in clusters inclusive of critical nuclear quantum effects. This approach is based on the recently developed quantum wavepacket ab initio molecular dynamics method that combines quantum wavepacket dynamics with ab initio molecular dynamics. The computational efficiency of the dynamical procedure is drastically improved (by several orders of magnitude) through the utilization of wavelet-based techniques combined with the previously introduced time-dependent deterministic sampling procedure measure to achieve stable, picosecond length, quantum-classical dynamics of electrons and nuclei in clusters. The dynamical information is employed to construct a novel cumulative flux/velocity correlation function, where the wavepacket flux from the quantized particle is combined with classical nuclear velocities to obtain the vibrational density of states. The approach is demonstrated by computing the vibrational density of states of [Cl-H-Cl]-, inclusive of critical quantum nuclear effects, and our results are in good agreement with experiment. A general hierarchical procedure is also provided, based on electronic structure harmonic frequencies, classical ab initio molecular dynamics, computation of nuclear quantum-mechanical eigenstates, and employing quantum wavepacket ab initio dynamics to understand vibrational spectroscopy in hydrogen-bonded clusters that display large degrees of anharmonicities.

  15. DYNAMIC SURFACE BOUNDARY-CONDITIONS - A SIMPLE BOUNDARY MODEL FOR MOLECULAR-DYNAMICS SIMULATIONS

    NARCIS (Netherlands)

    JUFFER, AH; BERENDSEN, HJC

    1993-01-01

    A simple model for the treatment of boundaries in molecular dynamics simulations is presented. The method involves the positioning of boundary atoms on a surface that surrounds a system of interest. The boundary atoms interact with the inner region and represent the effect of atoms outside the

  16. New Complexity Scalable MPEG Encoding Techniques for Mobile Applications

    Directory of Open Access Journals (Sweden)

    Stephan Mietens

    2004-03-01

    Full Text Available Complexity scalability offers the advantage of one-time design of video applications for a large product family, including mobile devices, without the need of redesigning the applications on the algorithmic level to meet the requirements of the different products. In this paper, we present complexity scalable MPEG encoding having core modules with modifications for scalability. The interdependencies of the scalable modules and the system performance are evaluated. Experimental results show scalability giving a smooth change in complexity and corresponding video quality. Scalability is basically achieved by varying the number of computed DCT coefficients and the number of evaluated motion vectors but other modules are designed such they scale with the previous parameters. In the experiments using the “Stefan” sequence, the elapsed execution time of the scalable encoder, reflecting the computational complexity, can be gradually reduced to roughly 50% of its original execution time. The video quality scales between 20 dB and 48 dB PSNR with unity quantizer setting, and between 21.5 dB and 38.5 dB PSNR for different sequences targeting 1500 kbps. The implemented encoder and the scalability techniques can be successfully applied in mobile systems based on MPEG video compression.

  17. Molecular dynamics simulations and quantum chemical calculations ...

    African Journals Online (AJOL)

    Molecular dynamic simulation results indicate that the imidazoline derivative molecules uses the imidazoline ring to effectively adsorb on the surface of iron, with the alkyl hydrophobic tail forming an n shape (canopy like covering) at geometry optimization and at 353 K. The n shape canopy like covering to a large extent may ...

  18. Molecular dynamics simulations from putative transition states of alpha-spectrin SH3 domain

    NARCIS (Netherlands)

    Periole, Xavier; Vendruscolo, Michele; Mark, Alan E.

    2007-01-01

    A series of molecular dynamics simulations in explicit solvent were started from nine structural models of the transition state of the SH3 domain of alpha-spectrin, which were generated by Lindorff Larsen et al. (Nat Struct Mol Biol 2004;11:443-449) using molecular dynamics simulations in which

  19. Droplet spreading driven by van der Waals force: a molecular dynamics study

    KAUST Repository

    Wu, Congmin

    2010-07-07

    The dynamics of droplet spreading is investigated by molecular dynamics simulations for two immiscible fluids of equal density and viscosity. All the molecular interactions are modeled by truncated Lennard-Jones potentials and a long-range van der Waals force is introduced to act on the wetting fluid. By gradually increasing the coupling constant in the attractive van der Waals interaction between the wetting fluid and the substrate, we observe a transition in the initial stage of spreading. There exists a critical value of the coupling constant, above which the spreading is pioneered by a precursor film. In particular, the dynamically determined critical value quantitatively agrees with that determined by the energy criterion that the spreading coefficient equals zero. The latter separates partial wetting from complete wetting. In the regime of complete wetting, the radius of the spreading droplet varies with time as R(t) ∼ √t, a behavior also found in molecular dynamics simulations where the wetting dynamics is driven by the short-range Lennard-Jones interaction between liquid and solid. © 2010 IOP Publishing Ltd.

  20. A graph algebra for scalable visual analytics.

    Science.gov (United States)

    Shaverdian, Anna A; Zhou, Hao; Michailidis, George; Jagadish, Hosagrahar V

    2012-01-01

    Visual analytics (VA), which combines analytical techniques with advanced visualization features, is fast becoming a standard tool for extracting information from graph data. Researchers have developed many tools for this purpose, suggesting a need for formal methods to guide these tools' creation. Increased data demands on computing requires redesigning VA tools to consider performance and reliability in the context of analysis of exascale datasets. Furthermore, visual analysts need a way to document their analyses for reuse and results justification. A VA graph framework encapsulated in a graph algebra helps address these needs. Its atomic operators include selection and aggregation. The framework employs a visual operator and supports dynamic attributes of data to enable scalable visual exploration of data.

  1. Molecular dynamics simulations of melting behavior of alkane as phase change materials slurry

    International Nuclear Information System (INIS)

    Rao Zhonghao; Wang Shuangfeng; Wu Maochun; Zhang Yanlai; Li Fuhuo

    2012-01-01

    Highlights: ► The melting behavior of phase change materials slurry was investigated by molecular dynamics simulation method. ► Four different PCM slurry systems including pure water and water/n-nonadecane composite were constructed. ► Amorphous structure and periodic boundary conditions were used in the molecular dynamics simulations. ► The simulated melting temperatures are very close to the published experimental values. - Abstract: The alkane based phase change materials slurry, with high latent heat storage capacity, is effective to enhance the heat transfer rate of traditional fluid. In this paper, the melting behavior of composite phase change materials slurry which consists of n-nonadecane and water was investigated by using molecular dynamics simulation. Four different systems including pure water and water/n-nonadecane composite were constructed with amorphous structure and periodic boundary conditions. The results showed that the simulated density and melting temperature were very close to the published experimental values. Mixing the n-nonadecane into water decreased the mobility but increased the energy storage capacity of composite systems. To describe the melting behavior of alkane based phase change materials slurry on molecular or atomic scale, molecular dynamics simulation is an effective method.

  2. Magnetic nanoparticles in fluid environment: combining molecular dynamics and Lattice-Boltzmann

    Energy Technology Data Exchange (ETDEWEB)

    Melenev, Petr, E-mail: melenev@icmm.ru [Ural Federal University, 4, Turgeneva str., 620000 Ekaterinburg (Russian Federation); Institute of Continuous Media Mechanics, 1, Koroleva str., 614013 Perm (Russian Federation)

    2017-06-01

    Hydrodynamic interactions between magnetic nanoparticles suspended in the Newtonian liquid are accounted for using a combination of the lattice Boltzmann method and molecular dynamics simulations. Nanoparticle is modelled by the system of molecular dynamics material points (which form structure resembles raspberry) coupled to the lattice Boltzmann fluid. The hydrodynamic coupling between the colloids is studied by simulations of the thermo-induced rotational diffusion of two raspberry objects. It was found that for the considered range of model parameters the approaching of the raspberries leads to slight retard of the relaxation process. The presence of the weak magnetic dipolar interaction between the objects leads to modest decrease of the relaxation time and the extent of the acceleration of the diffusion is intensified along with magnetic forces. - Highlights: • The combination of molecular dynamics and lattice Boltzmann method is utilized for the reveal of the role of hydrodynamic interaction in rotational dynamics of colloid particles. • The verification of the model parameters is done based on the comparison with the results of Langevin dynamics. • For the task of free rotational diffusion of the pair of colloid particles the influence of the hydrodynamic interactions on the relaxation time is examined in the case of nonmagnetic particles and at the presence of weak dipolar interaction.

  3. Microsecond atomic-scale molecular dynamics simulations of polyimides

    NARCIS (Netherlands)

    Lyulin, S.V.; Gurtovenko, A.A.; Larin, S.V.; Nazarychev, V.M.; Lyulin, A.V.

    2013-01-01

    We employ microsecond atomic-scale molecular dynamics simulations to get insight into the structural and thermal properties of heat-resistant bulk polyimides. As electrostatic interactions are essential for the polyimides considered, we propose a two-step equilibration protocol that includes long

  4. Emulating Molecular Orbitals and Electronic Dynamics with Ultracold Atoms

    Directory of Open Access Journals (Sweden)

    Dirk-Sören Lühmann

    2015-08-01

    Full Text Available In recent years, ultracold atoms in optical lattices have proven their great value as quantum simulators for studying strongly correlated phases and complex phenomena in solid-state systems. Here, we reveal their potential as quantum simulators for molecular physics and propose a technique to image the three-dimensional molecular orbitals with high resolution. The outstanding tunability of ultracold atoms in terms of potential and interaction offer fully adjustable model systems for gaining deep insight into the electronic structure of molecules. We study the orbitals of an artificial benzene molecule and discuss the effect of tunable interactions in its conjugated π electron system with special regard to localization and spin order. The dynamical time scales of ultracold atom simulators are on the order of milliseconds, which allows for the time-resolved monitoring of a broad range of dynamical processes. As an example, we compute the hole dynamics in the conjugated π system of the artificial benzene molecule.

  5. Moving contact lines: linking molecular dynamics and continuum-scale modelling.

    Science.gov (United States)

    Smith, Edward R; Theodorakis, Panagiotis E; Craster, Richard V; Matar, Omar K

    2018-05-04

    Despite decades of research, the modelling of moving contact lines has remained a formidable challenge in fluid dynamics whose resolution will impact numerous industrial, biological, and daily-life applications. On the one hand, molecular dynamics (MD) simulation has the ability to provide unique insight into the microscopic details that determine the dynamic behavior of the contact line, which is not possible with either continuum-scale simulations or experiments. On the other hand, continuum-based models provide the link to the macroscopic description of the system. In this Feature Article, we explore the complex range of physical factors, including the presence of surfactants, which govern the contact line motion through MD simulations. We also discuss links between continuum- and molecular-scale modelling, and highlight the opportunities for future developments in this area.

  6. Dynamic combinatorial libraries: from exploring molecular recognition to systems chemistry.

    Science.gov (United States)

    Li, Jianwei; Nowak, Piotr; Otto, Sijbren

    2013-06-26

    Dynamic combinatorial chemistry (DCC) is a subset of combinatorial chemistry where the library members interconvert continuously by exchanging building blocks with each other. Dynamic combinatorial libraries (DCLs) are powerful tools for discovering the unexpected and have given rise to many fascinating molecules, ranging from interlocked structures to self-replicators. Furthermore, dynamic combinatorial molecular networks can produce emergent properties at systems level, which provide exciting new opportunities in systems chemistry. In this perspective we will highlight some new methodologies in this field and analyze selected examples of DCLs that are under thermodynamic control, leading to synthetic receptors, catalytic systems, and complex self-assembled supramolecular architectures. Also reviewed are extensions of the principles of DCC to systems that are not at equilibrium and may therefore harbor richer functional behavior. Examples include self-replication and molecular machines.

  7. Estimation of flow stress of radiation induced F/M steels using molecular dynamics and discrete dislocation dynamics approach

    International Nuclear Information System (INIS)

    More, Ameya; Dutta, B.K.; Durgaprasad, P.V.; Arya, A.K.

    2012-01-01

    Fe-Cr based Ferritic/Martensitic (F/M) steels are the candidate structural materials for future fusion reactors. In this work, a multi-scale approach comprising atomistic Molecular Dynamics (MD) simulations and Discrete Dislocation Dynamics (DDD) simulations are used to model the effect of irradiation dose on the flow stress of F/M steels. At the atomic scale, molecular dynamics simulations are used to study the dislocation interaction with irradiation induced defects, i.e. voids and He bubbles. Whereas, the DDD simulations are used to estimate the change in flow stress of the material as a result of irradiation hardening. (author)

  8. Molecular dynamics studies of superionic conductors

    International Nuclear Information System (INIS)

    Rahman, A.; Vashishta, P.

    1983-01-01

    Structural and dynamical properties of superionic conductors AgI and CuI are studied using molecular dynamics (MD) techniques. The model of these superionic conductors is based on the use of effective pair potentials. To determine the constants in these potentials, cohesive energy and bulk modulus are used as input: in addition one uses notions of ionic size based on the known crystal structure. Salient features of the MD technique are outlined. Methods of treating long range Coulomb forces are discussed in detail. This includes the manner of doing Ewald sum for MD cells of arbitrary shape. Features that can be incorporated to expedite the MD calculations are also discussed. A novel MD technique which allows for a dynamically controlled variation of the shape and size of the MD cell is described briefly. The development of this novel technique has made it possible to study structural phase transitions in superionic conductors. 68 references, 17 figures, 2 tables

  9. Nonequilibrium molecular dynamics theory, algorithms and applications

    CERN Document Server

    Todd, Billy D

    2017-01-01

    Written by two specialists with over twenty-five years of experience in the field, this valuable text presents a wide range of topics within the growing field of nonequilibrium molecular dynamics (NEMD). It introduces theories which are fundamental to the field - namely, nonequilibrium statistical mechanics and nonequilibrium thermodynamics - and provides state-of-the-art algorithms and advice for designing reliable NEMD code, as well as examining applications for both atomic and molecular fluids. It discusses homogenous and inhomogenous flows and pays considerable attention to highly confined fluids, such as nanofluidics. In addition to statistical mechanics and thermodynamics, the book covers the themes of temperature and thermodynamic fluxes and their computation, the theory and algorithms for homogenous shear and elongational flows, response theory and its applications, heat and mass transport algorithms, applications in molecular rheology, highly confined fluids (nanofluidics), the phenomenon of slip and...

  10. Molecular dynamics simulation of the formation, structure, and dynamics of small phospholipid vesicles

    NARCIS (Netherlands)

    Marrink, SJ; Mark, AE

    2003-01-01

    Here, we use coarse grained molecular dynamics (MD) simulations to study the spontaneous aggregation of dipalmitoylphosphatidylcholine (DPPC) lipids into small unilamellar vesicles. We show that the aggregation process occurs on a nanosecond time scale, with bicelles and cuplike vesicles formed at

  11. Pressure-area isotherm of a lipid monolayer from molecular dynamics simulations

    NARCIS (Netherlands)

    Baoukina, Svetlana; Monticelli, Luca; Marrink, Siewert J.; Tieleman, D. Peter

    2007-01-01

    We calculated the pressure-area isotherm of a dipalmitoyl-phosphatidylcholine (DPPC) lipid monolayer from molecular dynamics simulations using a coarse-grained molecular model. We characterized the monolayer structure, geometry, and phases directly from the simulations and compared the calculated

  12. Quantum molecular dynamics study of the Su-Schrieffer-Heeger model

    NARCIS (Netherlands)

    Michielsen, Kristel; Raedt, Hans De

    A quantum molecular dynamics technique is presented to compute the static and dynamic properties of a system of fermions coupled to classical degrees of freedom. The method is employed to investigate the properties of the Su-Schrieffer-Heeger model, an electron-phonon model which is often used to

  13. A comparative molecular dynamics study of diffusion of n-decane ...

    Indian Academy of Sciences (India)

    Administrator

    Abstract. Molecular dynamics simulations are reported on the structure and dynamics of n-decane and. 3-methylpentane in zeolite NaY. We have calculated several properties such as the center of mass-center of mass rdf, the end-end distance distribution, bond angle distribution and dihedral angle distribution. We.

  14. Molecular Interactions and Reaction Dynamics in Supercritical Water Oxidation

    National Research Council Canada - National Science Library

    Johnston, K

    1998-01-01

    .... From UV-vis spectroscopic measurements and molecular dynamics simulation of chemical equilibria, we have shown that density effects on broad classes of reactions may be explained in terms of changes...

  15. Friction in Carborane-Based Molecular Rotors Driven by Gas Flow or Electric Field: Classical Molecular Dynamics

    Czech Academy of Sciences Publication Activity Database

    Prokop, Alexandr; Vacek, Jaroslav; Michl, Josef

    2012-01-01

    Roč. 6, č. 3 (2012), s. 1901-1914 ISSN 1936-0851 R&D Projects: GA ČR GA203/09/1802; GA MŠk ME09020 Institutional research plan: CEZ:AV0Z40550506 Keywords : molecular rotors * molecular dynamics * potential energy barriers * friction * intramolecular vibrational redistribution Subject RIV: CC - Organic Chemistry Impact factor: 12.062, year: 2012

  16. Classical molecular dynamics simulations of fusion and fragmentation in fullerene-fullerene collisions

    International Nuclear Information System (INIS)

    Verkhovtsev, A.; Korol, A.V.; Solovyov, A.V.

    2017-01-01

    We present the results of classical molecular dynamics simulations of collision-induced fusion and fragmentation of C 60 fullerenes, performed by means of the MBN Explorer software package. The simulations provide information on structural differences of the fused compound depending on kinematics of the collision process. The analysis of fragmentation dynamics at different initial conditions shows that the size distributions of produced molecular fragments are peaked for dimers, which is in agreement with a well-established mechanism of C 60 fragmentation via preferential C 2 emission. Atomic trajectories of the colliding particles are analyzed and different fragmentation patterns are observed and discussed. On the basis of the performed simulations, characteristic time of C 2 emission is estimated as a function of collision energy. The results are compared with experimental time-of-flight distributions of molecular fragments and with earlier theoretical studies. Considering the widely explored case study of C 60 -C 60 collisions, we demonstrate broad capabilities of the MBN Explorer software, which can be utilized for studying collisions of a broad variety of nano-scale and bio-molecular systems by means of classical molecular dynamics. (authors)

  17. Balancing an accurate representation of the molecular surface in generalized Born formalisms with integrator stability in molecular dynamics simulations

    Czech Academy of Sciences Publication Activity Database

    Chocholoušová, Jana; Feig, M.

    2006-01-01

    Roč. 27, č. 6 (2006), s. 719-729 ISSN 0192-8651 Keywords : molecular surface * generalized Born formalisms * molecular dynamic simulations Subject RIV: CC - Organic Chemistry Impact factor: 4.893, year: 2006

  18. Atomic and Molecular Dynamics on and in Superfluid Helium Nanodroplets

    Science.gov (United States)

    Lehmann, Kevin K.

    2003-03-01

    Studies of intramolecular and intermolecular dynamics is at the core of Molecular Spectroscopic research several decades. Gas phase, particularly molecular beam, studies have greatly illuminated these processes in isolated molecules, bimolecular collisions, or small covalent and van der Waals complexes. Parallel to this effort have been studies in condensed phases, but there has unfortunately been little intellectual contact between these. The recent development of Helium Nanodropet Isolation Spectroscopy is providing an intellectual bridge between gas phase and condensed phase spectroscopy. While droplets of 10,000 He atoms are effectively a condensed phase, their low temperature ( 0.4 K) and ultralow heat capacities combined with their superfluid state make them an almost ideal matrix in which to study both molecular dynamics, including solute induced relaxations. The nsec times scales for many of the relaxation events, orders of magnitude slower than in classical liquids, results in spectra with unprecedented resolution for the liquid state. In this talk, studies of the Princeton group will be highlighted, with particular emphasis on those for which a combination of theory and experiment have combined to reveal dynamics in this unique Quantum Fluid.

  19. Scalable fast multipole methods for vortex element methods

    KAUST Repository

    Hu, Qi

    2012-11-01

    We use a particle-based method to simulate incompressible flows, where the Fast Multipole Method (FMM) is used to accelerate the calculation of particle interactions. The most time-consuming kernelsâ\\'the Biot-Savart equation and stretching term of the vorticity equationâ\\'are mathematically reformulated so that only two Laplace scalar potentials are used instead of six, while automatically ensuring divergence-free far-field computation. Based on this formulation, and on our previous work for a scalar heterogeneous FMM algorithm, we develop a new FMM-based vortex method capable of simulating general flows including turbulence on heterogeneous architectures, which distributes the work between multi-core CPUs and GPUs to best utilize the hardware resources and achieve excellent scalability. The algorithm also uses new data structures which can dynamically manage inter-node communication and load balance efficiently but with only a small parallel construction overhead. This algorithm can scale to large-sized clusters showing both strong and weak scalability. Careful error and timing trade-off analysis are also performed for the cutoff functions induced by the vortex particle method. Our implementation can perform one time step of the velocity+stretching for one billion particles on 32 nodes in 55.9 seconds, which yields 49.12 Tflop/s. © 2012 IEEE.

  20. Accelerating convergence of molecular dynamics-based structural relaxation

    DEFF Research Database (Denmark)

    Christensen, Asbjørn

    2005-01-01

    We describe strategies to accelerate the terminal stage of molecular dynamics (MD)based relaxation algorithms, where a large fraction of the computational resources are used. First, we analyze the qualitative and quantitative behavior of the QuickMin family of MD relaxation algorithms and explore...

  1. Molecular Dynamics Investigation of Efficient SO₂ Absorption by ...

    Indian Academy of Sciences (India)

    Ionic liquids are appropriate candidates for the absorption of acid gases such as SO₂. Six anion functionalized ionic liquids with different basicities have been studied for SO₂ absorption capacity by employing quantum chemical calculations and molecular dynamics (MD) simulations. Gas phase quantum calculations ...

  2. DyNet: visualization and analysis of dynamic molecular interaction networks.

    Science.gov (United States)

    Goenawan, Ivan H; Bryan, Kenneth; Lynn, David J

    2016-09-01

    : The ability to experimentally determine molecular interactions on an almost proteome-wide scale under different conditions is enabling researchers to move from static to dynamic network analysis, uncovering new insights into how interaction networks are physically rewired in response to different stimuli and in disease. Dynamic interaction data presents a special challenge in network biology. Here, we present DyNet, a Cytoscape application that provides a range of functionalities for the visualization, real-time synchronization and analysis of large multi-state dynamic molecular interaction networks enabling users to quickly identify and analyze the most 'rewired' nodes across many network states. DyNet is available at the Cytoscape (3.2+) App Store (http://apps.cytoscape.org/apps/dynet). david.lynn@sahmri.com Supplementary data are available at Bioinformatics online. © The Author 2016. Published by Oxford University Press.

  3. Molecular dynamics for irradiation driven chemistry: application to the FEBID process*

    Science.gov (United States)

    Sushko, Gennady B.; Solov'yov, Ilia A.; Solov'yov, Andrey V.

    2016-10-01

    A new molecular dynamics (MD) approach for computer simulations of irradiation driven chemical transformations of complex molecular systems is suggested. The approach is based on the fact that irradiation induced quantum transformations can often be treated as random, fast and local processes involving small molecules or molecular fragments. We advocate that the quantum transformations, such as molecular bond breaks, creation and annihilation of dangling bonds, electronic charge redistributions, changes in molecular topologies, etc., could be incorporated locally into the molecular force fields that describe the classical MD of complex molecular systems under irradiation. The proposed irradiation driven molecular dynamics (IDMD) methodology is designed for the molecular level description of the irradiation driven chemistry. The IDMD approach is implemented into the MBN Explorer software package capable to operate with a large library of classical potentials, many-body force fields and their combinations. IDMD opens a broad range of possibilities for modelling of irradiation driven modifications and chemistry of complex molecular systems ranging from radiotherapy cancer treatments to the modern technologies such as focused electron beam deposition (FEBID). As an example, the new methodology is applied for studying the irradiation driven chemistry caused by FEBID of tungsten hexacarbonyl W(CO)6 precursor molecules on a hydroxylated SiO2 surface. It is demonstrated that knowing the interaction parameters for the fragments of the molecular system arising in the course of irradiation one can reproduce reasonably well experimental observations and make predictions about the morphology and molecular composition of nanostructures that emerge on the surface during the FEBID process.

  4. A Coupling Tool for Parallel Molecular Dynamics-Continuum Simulations

    KAUST Repository

    Neumann, Philipp

    2012-06-01

    We present a tool for coupling Molecular Dynamics and continuum solvers. It is written in C++ and is meant to support the developers of hybrid molecular - continuum simulations in terms of both realisation of the respective coupling algorithm as well as parallel execution of the hybrid simulation. We describe the implementational concept of the tool and its parallel extensions. We particularly focus on the parallel execution of particle insertions into dense molecular systems and propose a respective parallel algorithm. Our implementations are validated for serial and parallel setups in two and three dimensions. © 2012 IEEE.

  5. Molecular electron recollision dynamics in intense circularly polarized laser pulses

    Science.gov (United States)

    Bandrauk, André D.; Yuan, Kai-Jun

    2018-04-01

    Extreme UV and x-ray table top light sources based on high-order harmonic generation (HHG) are focused now on circular polarization for the generation of circularly polarized attosecond pulses as new tools for controlling electron dynamics, such as charge transfer and migration and the generation of attosecond quantum electron currents for ultrafast magneto-optics. A fundamental electron dynamical process in HHG is laser induced electron recollision with the parent ion, well established theoretically and experimentally for linear polarization. We discuss molecular electron recollision dynamics in circular polarization by theoretical analysis and numerical simulation. The control of the polarization of HHG with circularly polarized ionizing pulses is examined and it is shown that bichromatic circularly polarized pulses enhance recollision dynamics, rendering HHG more efficient, especially in molecules because of their nonspherical symmetry. The polarization of the harmonics is found to be dependent on the compatibility of the rotational symmetry of the net electric field created by combinations of bichromatic circularly polarized pulses with the dynamical symmetry of molecules. We show how the field and molecule symmetry influences the electron recollision trajectories by a time-frequency analysis of harmonics. The results, in principle, offer new unique controllable tools in the study of attosecond molecular electron dynamics.

  6. Combining molecular dynamics with mesoscopic Green’s function reaction dynamics simulations

    Energy Technology Data Exchange (ETDEWEB)

    Vijaykumar, Adithya, E-mail: vijaykumar@amolf.nl [FOM Institute AMOLF, Science Park 104, 1098 XG Amsterdam (Netherlands); van ’t Hoff Institute for Molecular Sciences, University of Amsterdam, P.O. Box 94157, 1090 GD Amsterdam (Netherlands); Bolhuis, Peter G. [van ’t Hoff Institute for Molecular Sciences, University of Amsterdam, P.O. Box 94157, 1090 GD Amsterdam (Netherlands); Rein ten Wolde, Pieter, E-mail: p.t.wolde@amolf.nl [FOM Institute AMOLF, Science Park 104, 1098 XG Amsterdam (Netherlands)

    2015-12-07

    In many reaction-diffusion processes, ranging from biochemical networks, catalysis, to complex self-assembly, the spatial distribution of the reactants and the stochastic character of their interactions are crucial for the macroscopic behavior. The recently developed mesoscopic Green’s Function Reaction Dynamics (GFRD) method enables efficient simulation at the particle level provided the microscopic dynamics can be integrated out. Yet, many processes exhibit non-trivial microscopic dynamics that can qualitatively change the macroscopic behavior, calling for an atomistic, microscopic description. We propose a novel approach that combines GFRD for simulating the system at the mesoscopic scale where particles are far apart, with a microscopic technique such as Langevin dynamics or Molecular Dynamics (MD), for simulating the system at the microscopic scale where reactants are in close proximity. This scheme defines the regions where the particles are close together and simulated with high microscopic resolution and those where they are far apart and simulated with lower mesoscopic resolution, adaptively on the fly. The new multi-scale scheme, called MD-GFRD, is generic and can be used to efficiently simulate reaction-diffusion systems at the particle level.

  7. Combining molecular dynamics with mesoscopic Green’s function reaction dynamics simulations

    International Nuclear Information System (INIS)

    Vijaykumar, Adithya; Bolhuis, Peter G.; Rein ten Wolde, Pieter

    2015-01-01

    In many reaction-diffusion processes, ranging from biochemical networks, catalysis, to complex self-assembly, the spatial distribution of the reactants and the stochastic character of their interactions are crucial for the macroscopic behavior. The recently developed mesoscopic Green’s Function Reaction Dynamics (GFRD) method enables efficient simulation at the particle level provided the microscopic dynamics can be integrated out. Yet, many processes exhibit non-trivial microscopic dynamics that can qualitatively change the macroscopic behavior, calling for an atomistic, microscopic description. We propose a novel approach that combines GFRD for simulating the system at the mesoscopic scale where particles are far apart, with a microscopic technique such as Langevin dynamics or Molecular Dynamics (MD), for simulating the system at the microscopic scale where reactants are in close proximity. This scheme defines the regions where the particles are close together and simulated with high microscopic resolution and those where they are far apart and simulated with lower mesoscopic resolution, adaptively on the fly. The new multi-scale scheme, called MD-GFRD, is generic and can be used to efficiently simulate reaction-diffusion systems at the particle level

  8. Human Skin Barrier Structure and Function Analyzed by Cryo-EM and Molecular Dynamics Simulation.

    Science.gov (United States)

    Lundborg, Magnus; Narangifard, Ali; Wennberg, Christian L; Lindahl, Erik; Daneholt, Bertil; Norlén, Lars

    2018-04-24

    In the present study we have analyzed the molecular structure and function of the human skin's permeability barrier using molecular dynamics simulation validated against cryo-electron microscopy data from near native skin. The skin's barrier capacity is located to an intercellular lipid structure embedding the cells of the superficial most layer of skin - the stratum corneum. According to the splayed bilayer model (Iwai et al., 2012) the lipid structure is organized as stacked bilayers of ceramides in a splayed chain conformation with cholesterol associated with the ceramide sphingoid moiety and free fatty acids associated with the ceramide fatty acid moiety. However, knowledge about the lipid structure's detailed molecular organization, and the roles of its different lipid constituents, remains circumstantial. Starting from a molecular dynamics model based on the splayed bilayer model, we have, by stepwise structural and compositional modifications, arrived at a thermodynamically stable molecular dynamics model expressing simulated electron microscopy patterns matching original cryo-electron microscopy patterns from skin extremely closely. Strikingly, the closer the individual molecular dynamics models' lipid composition was to that reported in human stratum corneum, the better was the match between the models' simulated electron microscopy patterns and the original cryo-electron microscopy patterns. Moreover, the closest-matching model's calculated water permeability and thermotropic behaviour were found compatible with that of human skin. The new model may facilitate more advanced physics-based skin permeability predictions of drugs and toxicants. The proposed procedure for molecular dynamics based analysis of cellular cryo-electron microscopy data might be applied to other biomolecular systems. Copyright © 2018. Published by Elsevier Inc.

  9. Scalable Quantum Simulation of Molecular Energies

    Directory of Open Access Journals (Sweden)

    P. J. J. O’Malley

    2016-07-01

    Full Text Available We report the first electronic structure calculation performed on a quantum computer without exponentially costly precompilation. We use a programmable array of superconducting qubits to compute the energy surface of molecular hydrogen using two distinct quantum algorithms. First, we experimentally execute the unitary coupled cluster method using the variational quantum eigensolver. Our efficient implementation predicts the correct dissociation energy to within chemical accuracy of the numerically exact result. Second, we experimentally demonstrate the canonical quantum algorithm for chemistry, which consists of Trotterization and quantum phase estimation. We compare the experimental performance of these approaches to show clear evidence that the variational quantum eigensolver is robust to certain errors. This error tolerance inspires hope that variational quantum simulations of classically intractable molecules may be viable in the near future.

  10. Molecular dynamics study of silver

    International Nuclear Information System (INIS)

    Akhter, J.I.; Yaldram, K.; Ahmad, W.; Khan, M.K.; Rehman, T.S.

    1995-03-01

    We present results of molecular dynamics study using the embedded atom potential to examine the equilibrium bulk properties of Ag. We calculate the total energy and the lattice parameters as a function of temperature. From these we determine the specific heat and linear coefficient of thermal expansion. The comparison with experimental results of these two quantities is found to be excellent. We have also calculated the mean square displacement of the atoms in the three directions. As expected because of symmetry the displacements in the three directions are comparable and increase with increasing temperature. (author) 5 figs

  11. Nonlinear dynamics of zigzag molecular chains (in Russian)

    DEFF Research Database (Denmark)

    Savin, A. V.; Manevitsch, L. I.; Christiansen, Peter Leth

    1999-01-01

    models (two-dimensional alpha-spiral, polyethylene transzigzag backbone, and the zigzag chain of hydrogen bonds) shows that the zigzag structure essentially limits the soliton dynamics to finite, relatively narrow, supersonic soliton velocity intervals and may also result in that several acoustic soliton......Nonlinear, collective, soliton type excitations in zigzag molecular chains are analyzed. It is shown that the nonlinear dynamics of a chain dramatically changes in passing from the one-dimensional linear chain to the more realistic planar zigzag model-due, in particular, to the geometry...

  12. Stability of molecular dynamics simulations of classical systems

    DEFF Research Database (Denmark)

    Toxværd, Søren

    2012-01-01

    The existence of a shadow Hamiltonian for discrete classical dynamics, obtained by an asymptotic expansion for a discrete symplectic algorithm, is employed to determine the limit of stability for molecular dynamics (MD) simulations with respect to the time-increment h of the discrete dynamics....... The investigation is based on the stability of the shadow energy, obtained by including the first term in the asymptotic expansion, and on the exact solution of discrete dynamics for a single harmonic mode. The exact solution of discrete dynamics for a harmonic potential with frequency ω gives a criterion...... for the limit of stability h ⩽ 2/ω. Simulations of the Lennard-Jones system and the viscous Kob-Andersen system show that one can use the limit of stability of the shadow energy or the stability criterion for a harmonic mode on the spectrum of instantaneous frequencies to determine the limit of stability of MD...

  13. Crystal structure and pair potentials: A molecular-dynamics study

    Energy Technology Data Exchange (ETDEWEB)

    Parrinello, M.; Rahman, A.

    1980-10-06

    With use of a Lagrangian which allows for the variation of the shape and size of the periodically repeating molecular-dynamics cell, it is shown that different pair potentials lead to different crystal structures.

  14. Molecular dynamics simulations and free energy profile of ...

    Indian Academy of Sciences (India)

    aDepartment of Chemical Engineering, bDepartment of Chemistry, Amirkabir University of Technology,. 15875-4413 ... Lipid bilayers; Paracetamol; free energy; molecular dynamics simulation; membrane. 1. ..... bilayer is less favourable due to the hydrophobic nature .... Orsi M and Essex J W 2010 Soft Matter 6 3797. 54.

  15. Microsecond molecular dynamics simulation shows effect of slow loop dynamics on backbone amide order parameters of proteins

    DEFF Research Database (Denmark)

    Maragakis, Paul; Lindorff-Larsen, Kresten; Eastwood, Michael P

    2008-01-01

    . Molecular dynamics (MD) simulation provides a complementary approach to the study of protein dynamics on similar time scales. Comparisons between NMR spectroscopy and MD simulations can be used to interpret experimental results and to improve the quality of simulation-related force fields and integration......A molecular-level understanding of the function of a protein requires knowledge of both its structural and dynamic properties. NMR spectroscopy allows the measurement of generalized order parameters that provide an atomistic description of picosecond and nanosecond fluctuations in protein structure...... methods. However, apparent systematic discrepancies between order parameters extracted from simulations and experiments are common, particularly for elements of noncanonical secondary structure. In this paper, results from a 1.2 micros explicit solvent MD simulation of the protein ubiquitin are compared...

  16. Plastic dislocation motion via nonequilibrium molecular and continuum dynamics

    International Nuclear Information System (INIS)

    Hoover, W.G.; Ladd, A.J.C.; Hoover, N.E.

    1980-01-01

    The classical two-dimensional close-packed triangular lattice, with nearest-neighbor spring forces, is a convenient standard material for the investigation of dislocation motion and plastic flow. Two kinds of calculations, based on this standard material, are described here: (1) Molecular Dynamics simulations, incorporating adiabatic strains described with the help of Doll's Tensor, and (2) Continuum Dynamics simulations, incorporating periodic boundaries and dislocation interaction through stress-field superposition

  17. Atomistic Molecular Dynamics Simulations of Mitochondrial DNA Polymerase γ

    DEFF Research Database (Denmark)

    Euro, Liliya; Haapanen, Outi; Róg, Tomasz

    2017-01-01

    of replisomal interactions, and functional effects of patient mutations that do not affect direct catalysis have remained elusive. Here we report the first atomistic classical molecular dynamics simulations of the human Pol γ replicative complex. Our simulation data show that DNA binding triggers remarkable......DNA polymerase γ (Pol γ) is a key component of the mitochondrial DNA replisome and an important cause of neurological diseases. Despite the availability of its crystal structures, the molecular mechanism of DNA replication, the switch between polymerase and exonuclease activities, the site...... changes in the enzyme structure, including (1) completion of the DNA-binding channel via a dynamic subdomain, which in the apo form blocks the catalytic site, (2) stabilization of the structure through the distal accessory β-subunit, and (3) formation of a putative transient replisome-binding platform...

  18. Enhancing protein adsorption simulations by using accelerated molecular dynamics.

    Directory of Open Access Journals (Sweden)

    Christian Mücksch

    Full Text Available The atomistic modeling of protein adsorption on surfaces is hampered by the different time scales of the simulation ([Formula: see text][Formula: see text]s and experiment (up to hours, and the accordingly different 'final' adsorption conformations. We provide evidence that the method of accelerated molecular dynamics is an efficient tool to obtain equilibrated adsorption states. As a model system we study the adsorption of the protein BMP-2 on graphite in an explicit salt water environment. We demonstrate that due to the considerably improved sampling of conformational space, accelerated molecular dynamics allows to observe the complete unfolding and spreading of the protein on the hydrophobic graphite surface. This result is in agreement with the general finding of protein denaturation upon contact with hydrophobic surfaces.

  19. Molecular Dynamics: New Frontier in Personalized Medicine.

    Science.gov (United States)

    Sneha, P; Doss, C George Priya

    2016-01-01

    The field of drug discovery has witnessed infinite development over the last decade with the demand for discovery of novel efficient lead compounds. Although the development of novel compounds in this field has seen large failure, a breakthrough in this area might be the establishment of personalized medicine. The trend of personalized medicine has shown stupendous growth being a hot topic after the successful completion of Human Genome Project and 1000 genomes pilot project. Genomic variant such as SNPs play a vital role with respect to inter individual's disease susceptibility and drug response. Hence, identification of such genetic variants has to be performed before administration of a drug. This process requires high-end techniques to understand the complexity of the molecules which might bring an insight to understand the compounds at their molecular level. To sustenance this, field of bioinformatics plays a crucial role in revealing the molecular mechanism of the mutation and thereby designing a drug for an individual in fast and affordable manner. High-end computational methods, such as molecular dynamics (MD) simulation has proved to be a constitutive approach to detecting the minor changes associated with an SNP for better understanding of the structural and functional relationship. The parameters used in molecular dynamic simulation elucidate different properties of a macromolecule, such as protein stability and flexibility. MD along with docking analysis can reveal the synergetic effect of an SNP in protein-ligand interaction and provides a foundation for designing a particular drug molecule for an individual. This compelling application of computational power and the advent of other technologies have paved a promising way toward personalized medicine. In this in-depth review, we tried to highlight the different wings of MD toward personalized medicine. © 2016 Elsevier Inc. All rights reserved.

  20. Molecular dynamics based enhanced sampling of collective variables with very large time steps

    Science.gov (United States)

    Chen, Pei-Yang; Tuckerman, Mark E.

    2018-01-01

    Enhanced sampling techniques that target a set of collective variables and that use molecular dynamics as the driving engine have seen widespread application in the computational molecular sciences as a means to explore the free-energy landscapes of complex systems. The use of molecular dynamics as the fundamental driver of the sampling requires the introduction of a time step whose magnitude is limited by the fastest motions in a system. While standard multiple time-stepping methods allow larger time steps to be employed for the slower and computationally more expensive forces, the maximum achievable increase in time step is limited by resonance phenomena, which inextricably couple fast and slow motions. Recently, we introduced deterministic and stochastic resonance-free multiple time step algorithms for molecular dynamics that solve this resonance problem and allow ten- to twenty-fold gains in the large time step compared to standard multiple time step algorithms [P. Minary et al., Phys. Rev. Lett. 93, 150201 (2004); B. Leimkuhler et al., Mol. Phys. 111, 3579-3594 (2013)]. These methods are based on the imposition of isokinetic constraints that couple the physical system to Nosé-Hoover chains or Nosé-Hoover Langevin schemes. In this paper, we show how to adapt these methods for collective variable-based enhanced sampling techniques, specifically adiabatic free-energy dynamics/temperature-accelerated molecular dynamics, unified free-energy dynamics, and by extension, metadynamics, thus allowing simulations employing these methods to employ similarly very large time steps. The combination of resonance-free multiple time step integrators with free-energy-based enhanced sampling significantly improves the efficiency of conformational exploration.

  1. Molecular dynamics simulations of elasto-hydrodynamic lubrication and boundary lubrication for automotive tribology

    International Nuclear Information System (INIS)

    Washizu, Hitoshi; Sanda, Shuzo; Hyodo, Shi-aki; Ohmori, Toshihide; Nishino, Noriaki; Suzuki, Atsushi

    2007-01-01

    Friction control of machine elements on a molecular level is a challenging subject in vehicle technology. We describe the molecular dynamics studies of friction in two significant lubrication regimes. As a case of elastohydrodynamic lubrication, we introduce the mechanism of momentum transfer related to the molecular structure of the hydrocarbon fluids, phase transition of the fluids under high pressure, and a submicron thickness simulation of the oil film using a tera-flops computer. For boundary lubrication, the dynamic behavior of water molecules on hydrophilic and hydrophobic silicon surfaces under a shear condition is studied. The dynamic structure of the hydrogen bond network on the hydrophilic surface is related to the low friction of the diamond-like carbon containing silicon (DLC-Si) coating

  2. Dynamic analysis of electron density in the course of the internal motion of molecular system

    International Nuclear Information System (INIS)

    Tachibana, A.; Hori, K.; Asai, Y.; Yamabe, T.

    1984-01-01

    The general dynamic aspect of electron density of a molecular system is studied on the basis of the general equation of the electron orbital which is formulated for the dynamic study of electronic motion. The newly defined electron orbital incorporates the dynamics of molecular vibration into the electronic structures. In this scheme, the change of electron distribution caused by excitation of vibrational state is defined as the ''dynamic electron transfer.'' The dynamic electron density is found to have the remarkable ''additive'' property. The time-dependent aspect of the dynamic electron redistribution is also analyzed on the basis of the ''coherent state.'' The new method relates the classical vibrational amplitude to the quantum number of the vibrational state. As a preliminary application of the present treatment, the dynamic electron densities of H 2 , HD, HT, HF, and HCl molecules are calculated by use of ab initio molecular orbital method

  3. Molecular dynamic analysis of the structure of dendrimers

    Energy Technology Data Exchange (ETDEWEB)

    Canetta, E.; Maino, G. E-mail: maino@bologna.enea.it

    2004-01-01

    We present main results of molecular dynamics simulations that we have carried out in order to investigate structural properties of polyamidoamine (PAMAM) dendrimers. Obtained data confirm the PAMAM dendrimer structure proposed by experiments, performed by means of X-ray scattering (SAXS) and quasi-elastic light scattering (QELS) techniques.

  4. Molecular dynamic analysis of the structure of dendrimers

    International Nuclear Information System (INIS)

    Canetta, E.; Maino, G.

    2004-01-01

    We present main results of molecular dynamics simulations that we have carried out in order to investigate structural properties of polyamidoamine (PAMAM) dendrimers. Obtained data confirm the PAMAM dendrimer structure proposed by experiments, performed by means of X-ray scattering (SAXS) and quasi-elastic light scattering (QELS) techniques

  5. Free energy from molecular dynamics with multiple constraints

    NARCIS (Netherlands)

    den Otter, Wouter K.; Briels, Willem J.

    2000-01-01

    In molecular dynamics simulations of reacting systems, the key step to determining the equilibrium constant and the reaction rate is the calculation of the free energy as a function of the reaction coordinate. Intuitively the derivative of the free energy is equal to the average force needed to

  6. Molecular Dynamics and Bioactivity of a Novel Mutated Human ...

    African Journals Online (AJOL)

    Keywords: Parathyroid hormone, Mutation prediction, Molecular dynamics, RANKL/OPG, UAMS-32P cell. Tropical .... PTH1R were used as MD simulation starting points. A full-atom ... Values of RMSD, Rg, and potential energy evaluation ...

  7. Classical molecular dynamics simulation of nuclear fuels

    International Nuclear Information System (INIS)

    Devanathan, R.; Krack, M.; Bertolus, M.

    2015-01-01

    Molecular dynamics simulation using forces calculated from empirical potentials, commonly called classical molecular dynamics, is well suited to study primary damage production by irradiation, defect interactions with fission gas atoms, gas bubble nucleation, grain boundary effects on defect and gas bubble evolution in nuclear fuel, and the resulting changes in thermomechanical properties. This enables one to obtain insights into fundamental mechanisms governing the behaviour of nuclear fuel, as well as parameters that can be used as inputs for mesoscale models. The interaction potentials used for the force calculations are generated by fitting properties of interest to experimental data and electronic structure calculations (see Chapter 12). We present here the different types of potentials currently available for UO 2 and illustrations of applications to the description of the behaviour of this material under irradiation. The results obtained from the present generation of potentials for UO 2 are qualitatively similar, but quantitatively different. There is a need to refine these existing potentials to provide a better representation of the performance of polycrystalline fuel under a variety of operating conditions, develop models that are equipped to handle deviations from stoichiometry, and validate the models and assumptions used. (authors)

  8. Dynamics and Thermodynamics of Transthyretin Association from Molecular Dynamics Simulations

    Directory of Open Access Journals (Sweden)

    Cedrix J. Dongmo Foumthuim

    2018-01-01

    Full Text Available Molecular dynamics simulations are used in this work to probe the structural stability and the dynamics of engineered mutants of transthyretin (TTR, i.e., the double mutant F87M/L110M (MT-TTR and the triple mutant F87M/L110M/S117E (3M-TTR, in relation to wild-type. Free energy analysis from end-point simulations and statistical effective energy functions are used to analyze trajectories, revealing that mutations do not have major impact on protein structure but rather on protein association, shifting the equilibria towards dissociated species. The result is confirmed by the analysis of 3M-TTR which shows dissociation within the first 10 ns of the simulation, indicating that contacts are lost at the dimer-dimer interface, whereas dimers (formed by monomers which pair to form two extended β-sheets appear fairly stable. Overall the simulations provide a detailed view of the dynamics and thermodynamics of wild-type and mutant transthyretins and a rationale of the observed effects.

  9. The chaos and order in nuclear molecular dynamics

    International Nuclear Information System (INIS)

    Srokowski, T.

    1995-01-01

    The subject of the presented report is role of chaos in scattering processes in the frame of molecular dynamics. In this model, it is assumed that scattering particles (nuclei) consist of not-interacted components as alpha particles or 12 C, 16 O and 20 Ne clusters. The results show such effects as dynamical in stabilities and fractal structure as well as compound nuclei decay and heavy-ion fusion. The goal of the report is to make the reader more familiar with the chaos model and its application to nuclear phenomena. 157 refs, 40 figs

  10. Dynamics of Oxidation of Aluminum Nanoclusters using Variable Charge Molecular-Dynamics Simulations on Parallel Computers

    Science.gov (United States)

    Campbell, Timothy; Kalia, Rajiv K.; Nakano, Aiichiro; Vashishta, Priya; Ogata, Shuji; Rodgers, Stephen

    1999-06-01

    Oxidation of aluminum nanoclusters is investigated with a parallel molecular-dynamics approach based on dynamic charge transfer among atoms. Structural and dynamic correlations reveal that significant charge transfer gives rise to large negative pressure in the oxide which dominates the positive pressure due to steric forces. As a result, aluminum moves outward and oxygen moves towards the interior of the cluster with the aluminum diffusivity 60% higher than that of oxygen. A stable 40 Å thick amorphous oxide is formed; this is in excellent agreement with experiments.

  11. A Scalable Method for Regioselective 3-Acylation of 2-Substituted Indoles under Basic Conditions

    DEFF Research Database (Denmark)

    Johansson, Karl Henrik; Urruticoechea, Andoni; Larsen, Inna

    2015-01-01

    Privileged structures such as 2-arylindoles are recurrent molecular scaffolds in bioactive molecules. We here present an operationally simple, high yielding and scalable method for regioselective 3-acylation of 2-substituted indoles under basic conditions using functionalized acid chlorides. The ....... The method shows good tolerance to both electron-withdrawing and donating substituents on the indole scaffold and gives ready access to a variety of functionalized 3-acylindole building blocks suited for further derivatization....

  12. Integrating atomistic molecular dynamics simulations, experiments and network analysis to study protein dynamics: strength in unity

    Directory of Open Access Journals (Sweden)

    Elena ePapaleo

    2015-05-01

    Full Text Available In the last years, we have been observing remarkable improvements in the field of protein dynamics. Indeed, we can now study protein dynamics in atomistic details over several timescales with a rich portfolio of experimental and computational techniques. On one side, this provides us with the possibility to validate simulation methods and physical models against a broad range of experimental observables. On the other side, it also allows a complementary and comprehensive view on protein structure and dynamics. What is needed now is a better understanding of the link between the dynamic properties that we observe and the functional properties of these important cellular machines. To make progresses in this direction, we need to improve the physical models used to describe proteins and solvent in molecular dynamics, as well as to strengthen the integration of experiments and simulations to overcome their own limitations. Moreover, now that we have the means to study protein dynamics in great details, we need new tools to understand the information embedded in the protein ensembles and in their dynamic signature. With this aim in mind, we should enrich the current tools for analysis of biomolecular simulations with attention to the effects that can be propagated over long distances and are often associated to important biological functions. In this context, approaches inspired by network analysis can make an important contribution to the analysis of molecular dynamics simulations.

  13. Fermionic molecular dynamics for ground states and collisions of nuclei

    International Nuclear Information System (INIS)

    Feldmeier, H.; Bieler, K.; Schnack, J.

    1994-08-01

    The antisymmetric many-body trial state which describes a system of interacting fermions is parametrized in terms of localized wave packets. The equations of motion are derived from the time-dependent quantum variational principle. The resulting Fermionic Molecular Dynamics (FMD) equations include a wide range of semi-quantal to classical physics extending from deformed Hartree-Fock theory to Newtonian molecular dynamics. Conservation laws are discussed in connection with the choice of the trial state. The model is applied to heavy-ion collisions with which its basic features are illustrated. The results show a great variety of phenomena including deeply inelastic collisions, fusion, incomplete fusion, fragmentation, neck emission, promptly emitted nucleons and evaporation. (orig.)

  14. Emission spectroscopic studies on dynamics of molecular excitation and dissociation by controlled electron impact

    International Nuclear Information System (INIS)

    Ogawa, Teiichiro

    1986-01-01

    Emission spectrum by controlled electron impact has been a successful technique for the investigation of molecular dynamics. (1) Molecular excitation. Aromatic molecules give an optical emission similar to fluorescence. However, as is shown by the vibrational structure and the electron energy dependence of benzene emission, its excitation process is not necessarily optical. Some aliphatic molecules also exhibit an emission band at the ultraviolet region. (2) Molecular dissociation. Analysis of the Doppler profile, the threshold energy, the excitation function and the isotope effect of the atomic emission produced in electron-molecule collisions has clarified the dynamics of the molecular dissociation. Especially the Doppler profile has given the translational energy distribution of the fragment atom, which is very useful to disclose the potential energy curve. Its angular dependence has recently found to allow determination of the symmetry of the intermediate excited state and the magnetic sublevel distribution of the fragment atom. These finding has revealed detailed state-to-state dynamics of the molecular dissociation. (author)

  15. Effects of temperature and isotopic substitution on electron attachment dynamics of guanine–cytosine base pair: Ring-polymer and classical molecular dynamics simulations

    International Nuclear Information System (INIS)

    Minoshima, Yusuke; Seki, Yusuke; Takayanagi, Toshiyuki; Shiga, Motoyuki

    2016-01-01

    Highlights: • Dynamics of excess electron attachment to guanine–cytosine base pair. • Ring-polymer and classical molecular dynamics simulations are performed. • Temperature and isotope substitution effects are investigated. - Abstract: The dynamical process of electron attachment to a guanine–cytosine pair in the normal (h-GC) and deuterated (d-GC) forms has been studied theoretically by semiclassical ring-polymer molecular dynamics (RPMD) simulations using the empirical valence bond model. The initially formed dipole-bound anion is converted rapidly to the valence-bound anion within about 0.1 ps in both h-GC and d-GC. However, the subsequent proton transfer in h-GC occurs with a rate five times greater than the deuteron transfer in d-GC. The change of rates with isotopic substitution and temperature variation in the RPMD simulations are quantitatively and qualitatively different from those in the classical molecular dynamics (MD) simulations, demonstrating the importance of nuclear quantum effects on the dynamics of this system.

  16. Effects of temperature and isotopic substitution on electron attachment dynamics of guanine–cytosine base pair: Ring-polymer and classical molecular dynamics simulations

    Energy Technology Data Exchange (ETDEWEB)

    Minoshima, Yusuke; Seki, Yusuke [Department of Chemistry, Saitama University, 255 Shimo-Okubo, Sakura-ku, Saitama City, Saitama 338-8570 (Japan); Takayanagi, Toshiyuki, E-mail: tako@mail.saitama-u.ac.jp [Department of Chemistry, Saitama University, 255 Shimo-Okubo, Sakura-ku, Saitama City, Saitama 338-8570 (Japan); Shiga, Motoyuki [Center for Computational Science and E-Systems, Japan Atomic Energy Agency, 148-4, Kashiwanoha Campus, 178-4 Wakashiba, Kashiwa, Chiba 277-0871 (Japan)

    2016-06-15

    Highlights: • Dynamics of excess electron attachment to guanine–cytosine base pair. • Ring-polymer and classical molecular dynamics simulations are performed. • Temperature and isotope substitution effects are investigated. - Abstract: The dynamical process of electron attachment to a guanine–cytosine pair in the normal (h-GC) and deuterated (d-GC) forms has been studied theoretically by semiclassical ring-polymer molecular dynamics (RPMD) simulations using the empirical valence bond model. The initially formed dipole-bound anion is converted rapidly to the valence-bound anion within about 0.1 ps in both h-GC and d-GC. However, the subsequent proton transfer in h-GC occurs with a rate five times greater than the deuteron transfer in d-GC. The change of rates with isotopic substitution and temperature variation in the RPMD simulations are quantitatively and qualitatively different from those in the classical molecular dynamics (MD) simulations, demonstrating the importance of nuclear quantum effects on the dynamics of this system.

  17. Molecular dynamics simulation of a chemical reaction

    International Nuclear Information System (INIS)

    Gorecki, J.; Gryko, J.

    1988-06-01

    Molecular dynamics is used to study the chemical reaction A+A→B+B. It is shown that the reaction rate constant follows the Arrhenius law both for Lennard-Jones and hard sphere interaction potentials between substrate particles. A. For the denser systems the reaction rate is proportional to the value of the radial distribution function at the contact point of two hard spheres. 10 refs, 4 figs

  18. Photocatalytic oxidation dynamics of acetone on TiO2: tight-binding quantum chemical molecular dynamics study

    International Nuclear Information System (INIS)

    Lv Chen; Wang Xiaojing; Agalya, Govindasamy; Koyama, Michihisa; Kubo, Momoji; Miyamoto, Akira

    2005-01-01

    The clarification of the excited states dynamics on TiO 2 surface is important subject for the design of the highly active photocatalysts. In the present study, we applied our novel tight-binding quantum chemical molecular dynamics method to the investigation on the photocatalytic oxidation dynamics of acetone by photogenerated OH radicals on the hydrated anatase TiO 2 surface. The elucidated photocatalytic reaction mechanism strongly supports the previous experimental proposal and finally the effectiveness of our new approach for the clarification of the photocatalytic reaction dynamics employing the large simulation model was confirmed

  19. Charge-dependent conformations and dynamics of pamam dendrimers revealed by neutron scattering and molecular dynamics

    Science.gov (United States)

    Wu, Bin

    Neutron scattering and fully atomistic molecular dynamics (MD) are employed to investigate the structural and dynamical properties of polyamidoamine (PAMAM) dendrimers with ethylenediamine (EDA) core under various charge conditions. Regarding to the conformational characteristics, we focus on scrutinizing density profile evolution of PAMAM dendrimers as the molecular charge of dendrimer increases from neutral state to highly charged condition. It should be noted that within the context of small angle neutron scattering (SANS), the dendrimers are composed of hydrocarbon component (dry part) and the penetrating water molecules. Though there have been SANS experiments that studied the charge-dependent structural change of PAMAM dendrimers, their results were limited to the collective behavior of the aforementioned two parts. This study is devoted to deepen the understanding towards the structural responsiveness of intra-molecular polymeric and hydration parts separately through advanced contrast variation SANS data analysis scheme available recently and unravel the governing principles through coupling with MD simulations. Two kinds of acids, namely hydrochloric and sulfuric acids, are utilized to tune the pH condition and hence the molecular charge. As far as the dynamical properties, we target at understanding the underlying mechanism that leads to segmental dynamic enhancement observed from quasielstic neutron scattering (QENS) experiment previously. PAMAM dendrimers have a wealth of potential applications, such as drug delivery agency, energy harvesting medium, and light emitting diodes. More importantly, it is regarded as an ideal system to test many theoretical predictions since dendrimers conjugate both colloid-like globular shape and polymer-like flexible chains. This Ph.D. research addresses two main challenges in studying PAMAM dendrimers. Even though neutron scattering is an ideal tool to study this PAMAM dendrimer solution due to its matching temporal and

  20. Multilevel summation with B-spline interpolation for pairwise interactions in molecular dynamics simulations

    International Nuclear Information System (INIS)

    Hardy, David J.; Schulten, Klaus; Wolff, Matthew A.; Skeel, Robert D.; Xia, Jianlin

    2016-01-01

    The multilevel summation method for calculating electrostatic interactions in molecular dynamics simulations constructs an approximation to a pairwise interaction kernel and its gradient, which can be evaluated at a cost that scales linearly with the number of atoms. The method smoothly splits the kernel into a sum of partial kernels of increasing range and decreasing variability with the longer-range parts interpolated from grids of increasing coarseness. Multilevel summation is especially appropriate in the context of dynamics and minimization, because it can produce continuous gradients. This article explores the use of B-splines to increase the accuracy of the multilevel summation method (for nonperiodic boundaries) without incurring additional computation other than a preprocessing step (whose cost also scales linearly). To obtain accurate results efficiently involves technical difficulties, which are overcome by a novel preprocessing algorithm. Numerical experiments demonstrate that the resulting method offers substantial improvements in accuracy and that its performance is competitive with an implementation of the fast multipole method in general and markedly better for Hamiltonian formulations of molecular dynamics. The improvement is great enough to establish multilevel summation as a serious contender for calculating pairwise interactions in molecular dynamics simulations. In particular, the method appears to be uniquely capable for molecular dynamics in two situations, nonperiodic boundary conditions and massively parallel computation, where the fast Fourier transform employed in the particle–mesh Ewald method falls short.

  1. Analyzing the Molecular Kinetics of Water Spreading on Hydrophobic Surfaces via Molecular Dynamics Simulation.

    Science.gov (United States)

    Zhao, Lei; Cheng, Jiangtao

    2017-09-07

    In this paper, we report molecular kinetic analyses of water spreading on hydrophobic surfaces via molecular dynamics simulation. The hydrophobic surfaces are composed of amorphous polytetrafluoroethylene (PTFE) with a static contact angle of ~112.4° for water. On the basis of the molecular kinetic theory (MKT), the influences of both viscous damping and solid-liquid retarding were analyzed in evaluating contact line friction, which characterizes the frictional force on the contact line. The unit displacement length on PTFE was estimated to be ~0.621 nm and is ~4 times as long as the bond length of C-C backbone. The static friction coefficient was found to be ~[Formula: see text] Pa·s, which is on the same order of magnitude as the dynamic viscosity of water, and increases with the droplet size. A nondimensional number defined by the ratio of the standard deviation of wetting velocity to the characteristic wetting velocity was put forward to signify the strength of the inherent contact line fluctuation and unveil the mechanism of enhanced energy dissipation in nanoscale, whereas such effect would become insignificant in macroscale. Moreover, regarding a liquid droplet on hydrophobic or superhydrophobic surfaces, an approximate solution to the base radius development was derived by an asymptotic expansion approach.

  2. Stereochemical errors and their implications for molecular dynamics simulations

    Directory of Open Access Journals (Sweden)

    Freddolino Peter L

    2011-05-01

    Full Text Available Abstract Background Biological molecules are often asymmetric with respect to stereochemistry, and correct stereochemistry is essential to their function. Molecular dynamics simulations of biomolecules have increasingly become an integral part of biophysical research. However, stereochemical errors in biomolecular structures can have a dramatic impact on the results of simulations. Results Here we illustrate the effects that chirality and peptide bond configuration flips may have on the secondary structure of proteins throughout a simulation. We also analyze the most common sources of stereochemical errors in biomolecular structures and present software tools to identify, correct, and prevent stereochemical errors in molecular dynamics simulations of biomolecules. Conclusions Use of the tools presented here should become a standard step in the preparation of biomolecular simulations and in the generation of predicted structural models for proteins and nucleic acids.

  3. The Concept of Business Model Scalability

    DEFF Research Database (Denmark)

    Lund, Morten; Nielsen, Christian

    2018-01-01

    -term pro table business. However, the main message of this article is that while providing a good value proposition may help the rm ‘get by’, the really successful businesses of today are those able to reach the sweet-spot of business model scalability. Design/Methodology/Approach: The article is based...... on a ve-year longitudinal action research project of over 90 companies that participated in the International Center for Innovation project aimed at building 10 global network-based business models. Findings: This article introduces and discusses the term scalability from a company-level perspective......Purpose: The purpose of the article is to de ne what scalable business models are. Central to the contemporary understanding of business models is the value proposition towards the customer and the hypotheses generated about delivering value to the customer which become a good foundation for a long...

  4. Scalable implementation of ancilla-free optimal 1→M phase-covariant quantum cloning by combining quantum Zeno dynamics and adiabatic passage

    International Nuclear Information System (INIS)

    Shao, Xiao-Qiang; Zheng, Tai-Yu; Zhang, Shou

    2011-01-01

    A scalable way for implementation of ancilla-free optimal 1→M phase-covariant quantum cloning (PCC) is proposed by combining quantum Zeno dynamics and adiabatic passage. An optimal 1→M PCC can be achieved directly from the existed optimal 1→(M-1) PCC without excited states population during the whole process. The cases for optimal 1→3 (4) PCCs are discussed detailedly to show that the scheme is robust against the effect of decoherence. Moreover, the time for carrying out each cloning transformation is regular, which may reduce the complexity for achieving the optimal PCC in experiment. -- Highlights: → We implement the ancilla-free optimal 1→M phase-covariant quantum cloning machine. → This scheme is robust against the cavity decay and the spontaneous emission of atom. → The time for carrying out each cloning transformation is regular.

  5. Scalable implementation of ancilla-free optimal 1→M phase-covariant quantum cloning by combining quantum Zeno dynamics and adiabatic passage

    Energy Technology Data Exchange (ETDEWEB)

    Shao, Xiao-Qiang, E-mail: xqshao83@yahoo.cn [School of Physics, Northeast Normal University, Changchun 130024 (China); Zheng, Tai-Yu, E-mail: zhengty@nenu.edu.cn [School of Physics, Northeast Normal University, Changchun 130024 (China); Zhang, Shou [Department of Physics, College of Science, Yanbian University, Yanji, Jilin 133002 (China)

    2011-09-19

    A scalable way for implementation of ancilla-free optimal 1→M phase-covariant quantum cloning (PCC) is proposed by combining quantum Zeno dynamics and adiabatic passage. An optimal 1→M PCC can be achieved directly from the existed optimal 1→(M-1) PCC without excited states population during the whole process. The cases for optimal 1→3 (4) PCCs are discussed detailedly to show that the scheme is robust against the effect of decoherence. Moreover, the time for carrying out each cloning transformation is regular, which may reduce the complexity for achieving the optimal PCC in experiment. -- Highlights: → We implement the ancilla-free optimal 1→M phase-covariant quantum cloning machine. → This scheme is robust against the cavity decay and the spontaneous emission of atom. → The time for carrying out each cloning transformation is regular.

  6. In situ diffraction profile analysis during tensile deformation motivated by molecular dynamics

    International Nuclear Information System (INIS)

    Van Swygenhoven, H.; Budrovic, Z.; Derlet, P.M.; Froseth, A.G.; Van Petegem, S.

    2005-01-01

    Molecular dynamics simulations can provide insight into the slip mechanism at the atomic scale and suggest that in nanocrystalline metals dislocations are nucleated and absorbed by the grain boundaries. However, this technique is limited by very short simulation times. Using suggestions from molecular dynamics, we have developed a new in situ X-ray diffraction technique wherein the profile analysis of several Bragg diffraction peaks during tensile deformation is possible. Combining experiment and careful structural analysis the results confirm the suggestions from atomistic simulations

  7. Multiscale simulations of anisotropic particles combining molecular dynamics and Green's function reaction dynamics

    Science.gov (United States)

    Vijaykumar, Adithya; Ouldridge, Thomas E.; ten Wolde, Pieter Rein; Bolhuis, Peter G.

    2017-03-01

    The modeling of complex reaction-diffusion processes in, for instance, cellular biochemical networks or self-assembling soft matter can be tremendously sped up by employing a multiscale algorithm which combines the mesoscopic Green's Function Reaction Dynamics (GFRD) method with explicit stochastic Brownian, Langevin, or deterministic molecular dynamics to treat reactants at the microscopic scale [A. Vijaykumar, P. G. Bolhuis, and P. R. ten Wolde, J. Chem. Phys. 143, 214102 (2015)]. Here we extend this multiscale MD-GFRD approach to include the orientational dynamics that is crucial to describe the anisotropic interactions often prevalent in biomolecular systems. We present the novel algorithm focusing on Brownian dynamics only, although the methodology is generic. We illustrate the novel algorithm using a simple patchy particle model. After validation of the algorithm, we discuss its performance. The rotational Brownian dynamics MD-GFRD multiscale method will open up the possibility for large scale simulations of protein signalling networks.

  8. A molecular dynamics algorithm for simulation of field theories in the canonical ensemble

    International Nuclear Information System (INIS)

    Kogut, J.B.; Sinclair, D.K.

    1986-01-01

    We add a single scalar degree of freedom (''demon'') to the microcanonical ensemble which converts its molecular dynamics into a simulation method for the canonical ensemble (euclidean path integral) of the underlying field theory. This generalization of the microcanonical molecular dynamics algorithm simulates the field theory at fixed coupling with a completely deterministic procedure. We discuss the finite size effects of the method, the equipartition theorem and ergodicity. The method is applied to the planar model in two dimensions and SU(3) lattice gauge theory with four species of light, dynamical quarks in four dimensions. The method is much less sensitive to its discrete time step than conventional Langevin equation simulations of the canonical ensemble. The method is a straightforward generalization of a procedure introduced by S. Nose for molecular physics. (orig.)

  9. Statistical Measures to Quantify Similarity between Molecular Dynamics Simulation Trajectories

    Directory of Open Access Journals (Sweden)

    Jenny Farmer

    2017-11-01

    Full Text Available Molecular dynamics simulation is commonly employed to explore protein dynamics. Despite the disparate timescales between functional mechanisms and molecular dynamics (MD trajectories, functional differences are often inferred from differences in conformational ensembles between two proteins in structure-function studies that investigate the effect of mutations. A common measure to quantify differences in dynamics is the root mean square fluctuation (RMSF about the average position of residues defined by C α -atoms. Using six MD trajectories describing three native/mutant pairs of beta-lactamase, we make comparisons with additional measures that include Jensen-Shannon, modifications of Kullback-Leibler divergence, and local p-values from 1-sample Kolmogorov-Smirnov tests. These additional measures require knowing a probability density function, which we estimate by using a nonparametric maximum entropy method that quantifies rare events well. The same measures are applied to distance fluctuations between C α -atom pairs. Results from several implementations for quantitative comparison of a pair of MD trajectories are made based on fluctuations for on-residue and residue-residue local dynamics. We conclude that there is almost always a statistically significant difference between pairs of 100 ns all-atom simulations on moderate-sized proteins as evident from extraordinarily low p-values.

  10. Liquid-vapor coexistence by molecular dynamics simulation

    International Nuclear Information System (INIS)

    Baranyai, Andras; Cummings, Peter T.

    2000-01-01

    We present a simple and consistent molecular dynamics algorithm for determining the equilibrium properties of a bulk liquid and its coexisting vapor phase. The simulation follows the dynamics of the two systems simultaneously while maintaining the volume and the number of particles of the composite system fixed. The thermostat can constrain either the total energy or the temperature at a desired value. Division of the extensive properties between the two phases is governed by the difference of the corresponding intensive state variables. Particle numbers are continuous variables and vary only in virtual sense, i.e., the real sizes of the two systems are the same and do not change during the course of the simulation. Calculation of the chemical potential is separate from the dynamics; thus, one can replace the particle exchange step with other method if it improves the efficiency of the code. (c) 2000 American Institute of Physics

  11. Oracle database performance and scalability a quantitative approach

    CERN Document Server

    Liu, Henry H

    2011-01-01

    A data-driven, fact-based, quantitative text on Oracle performance and scalability With database concepts and theories clearly explained in Oracle's context, readers quickly learn how to fully leverage Oracle's performance and scalability capabilities at every stage of designing and developing an Oracle-based enterprise application. The book is based on the author's more than ten years of experience working with Oracle, and is filled with dependable, tested, and proven performance optimization techniques. Oracle Database Performance and Scalability is divided into four parts that enable reader

  12. PKI Scalability Issues

    OpenAIRE

    Slagell, Adam J; Bonilla, Rafael

    2004-01-01

    This report surveys different PKI technologies such as PKIX and SPKI and the issues of PKI that affect scalability. Much focus is spent on certificate revocation methodologies and status verification systems such as CRLs, Delta-CRLs, CRS, Certificate Revocation Trees, Windowed Certificate Revocation, OCSP, SCVP and DVCS.

  13. Comparative Investigation of Normal Modes and Molecular Dynamics of Hepatitis C NS5B Protein

    International Nuclear Information System (INIS)

    Asafi, M S; Tekpinar, M; Yildirim, A

    2016-01-01

    Understanding dynamics of proteins has many practical implications in terms of finding a cure for many protein related diseases. Normal mode analysis and molecular dynamics methods are widely used physics-based computational methods for investigating dynamics of proteins. In this work, we studied dynamics of Hepatitis C NS5B protein with molecular dynamics and normal mode analysis. Principal components obtained from a 100 nanoseconds molecular dynamics simulation show good overlaps with normal modes calculated with a coarse-grained elastic network model. Coarse-grained normal mode analysis takes at least an order of magnitude shorter time. Encouraged by this good overlaps and short computation times, we analyzed further low frequency normal modes of Hepatitis C NS5B. Motion directions and average spatial fluctuations have been analyzed in detail. Finally, biological implications of these motions in drug design efforts against Hepatitis C infections have been elaborated. (paper)

  14. On Scalability and Replicability of Smart Grid Projects—A Case Study

    Directory of Open Access Journals (Sweden)

    Lukas Sigrist

    2016-03-01

    Full Text Available This paper studies the scalability and replicability of smart grid projects. Currently, most smart grid projects are still in the R&D or demonstration phases. The full roll-out of the tested solutions requires a suitable degree of scalability and replicability to prevent project demonstrators from remaining local experimental exercises. Scalability and replicability are the preliminary requisites to perform scaling-up and replication successfully; therefore, scalability and replicability allow for or at least reduce barriers for the growth and reuse of the results of project demonstrators. The paper proposes factors that influence and condition a project’s scalability and replicability. These factors involve technical, economic, regulatory and stakeholder acceptance related aspects, and they describe requirements for scalability and replicability. In order to assess and evaluate the identified scalability and replicability factors, data has been collected from European and national smart grid projects by means of a survey, reflecting the projects’ view and results. The evaluation of the factors allows quantifying the status quo of on-going projects with respect to the scalability and replicability, i.e., they provide a feedback on to what extent projects take into account these factors and on whether the projects’ results and solutions are actually scalable and replicable.

  15. Molecular dynamics simulation of ribosome jam

    KAUST Repository

    Matsumoto, Shigenori

    2011-09-01

    We propose a coarse-grained molecular dynamics model of ribosome molecules to study the dependence of translation process on environmental parameters. We found the model exhibits traffic jam property, which is consistent with an ASEP model. We estimated the influence of the temperature and concentration of molecules on the hopping probability used in the ASEP model. Our model can also treat environmental effects on the translation process that cannot be explained by such cellular automaton models. © 2010 Elsevier B.V. All rights reserved.

  16. Structure and dynamics of photosynthetic proteins studied by neutron scattering and molecular dynamic simulation

    International Nuclear Information System (INIS)

    Dellerue, Serge

    2000-01-01

    Understand the structure-dynamics-function relation in the case of proteins is essential. But few experimental techniques allow to have access to knowledge of fast internal movements of biological macromolecules. With the neutron scattering method, it has been possible to study the reorientation dynamics of side chains and of polypeptide skeleton for two proteins in terms of water or detergent and of temperature. With the use of the molecular dynamics method, essential for completing and interpreting the experimental data, it has been possible to assess the different contributions of the whole structure of proteins to the overall dynamics. It has been shown that the polypeptide skeleton presents an energy relaxation comparable to those of the side chains. Moreover, it has been explained that the protein dynamics can only be understood in terms of relaxation time distribution. (author) [fr

  17. The Design, Synthesis, and Study of Solid-State Molecular Rotors: Structure/Function Relationships for Condensed-Phase Anisotropic Dynamics

    Science.gov (United States)

    Vogelsberg, Cortnie Sue

    Amphidynamic crystals are an extremely promising platform for the development of artificial molecular machines and stimuli-responsive materials. In analogy to skeletal muscle, their function will rely upon the collective operation of many densely packed molecular machines (i.e. actin-bound myosin) that are self-assembled in a highly organized anisotropic medium. By choosing lattice-forming elements and moving "parts" with specific functionalities, individual molecular machines may be synthesized and self-assembled in order to carry out desirable functions. In recent years, efforts in the design of amphidynamic materials based on molecular gyroscopes and compasses have shown that a certain amount of free volume is essential to facilitate internal rotation and reorientation within a crystal. In order to further establish structure/function relationships to advance the development of increasingly complex molecular machinery, molecular rotors and a molecular "spinning" top were synthesized and incorporated into a variety of solid-state architectures with different degrees of periodicity, dimensionality, and free volume. Specifically, lamellar molecular crystals, hierarchically ordered periodic mesoporous organosilicas, and metal-organic frameworks were targeted for the development of solid-state molecular machines. Using an array of solid-state nuclear magnetic resonance spectroscopy techniques, the dynamic properties of these novel molecular machine assemblies were determined and correlated with their corresponding structural features. It was found that architecture type has a profound influence on functional dynamics. The study of layered molecular crystals, composed of either molecular rotors or "spinning" tops, probed functional dynamics within dense, highly organized environments. From their study, it was discovered that: 1) crystallographically distinct sites may be utilized to differentiate machine function, 2) halogen bonding interactions are sufficiently

  18. POLYANA-A tool for the calculation of molecular radial distribution functions based on Molecular Dynamics trajectories

    Science.gov (United States)

    Dimitroulis, Christos; Raptis, Theophanes; Raptis, Vasilios

    2015-12-01

    We present an application for the calculation of radial distribution functions for molecular centres of mass, based on trajectories generated by molecular simulation methods (Molecular Dynamics, Monte Carlo). When designing this application, the emphasis was placed on ease of use as well as ease of further development. In its current version, the program can read trajectories generated by the well-known DL_POLY package, but it can be easily extended to handle other formats. It is also very easy to 'hack' the program so it can compute intermolecular radial distribution functions for groups of interaction sites rather than whole molecules.

  19. Molecular Dynamics with Helical Periodic Boundary Conditions

    Czech Academy of Sciences Publication Activity Database

    Kessler, Jiří; Bouř, Petr

    2014-01-01

    Roč. 35, č. 21 (2014), s. 1552-1559 ISSN 0192-8651 R&D Projects: GA ČR GAP208/11/0105; GA MŠk(CZ) LH11033 Grant - others:GA AV ČR(CZ) M200551205; GA MŠk(CZ) LM2010005 Institutional support: RVO:61388963 Keywords : periodic boundary conditions * helical symmetry * molecular dynamics * protein structure * amyloid fibrils Subject RIV: CF - Physical ; Theoretical Chemistry Impact factor: 3.589, year: 2014

  20. Scalable-to-lossless transform domain distributed video coding

    DEFF Research Database (Denmark)

    Huang, Xin; Ukhanova, Ann; Veselov, Anton

    2010-01-01

    Distributed video coding (DVC) is a novel approach providing new features as low complexity encoding by mainly exploiting the source statistics at the decoder based on the availability of decoder side information. In this paper, scalable-tolossless DVC is presented based on extending a lossy Tran...... codec provides frame by frame encoding. Comparing the lossless coding efficiency, the proposed scalable-to-lossless TDWZ video codec can save up to 5%-13% bits compared to JPEG LS and H.264 Intra frame lossless coding and do so as a scalable-to-lossless coding....

  1. Nonequilibrium and generalized-ensemble molecular dynamics simulations for amyloid fibril

    Energy Technology Data Exchange (ETDEWEB)

    Okumura, Hisashi [Research Center for Computational Science, Institute for Molecular Science, Okazaki, Aichi 444-8585 (Japan); Department of Structural Molecular Science, The Graduate University for Advanced Studies, Okazaki, Aichi 444-8585 (Japan)

    2015-12-31

    Amyloids are insoluble and misfolded fibrous protein aggregates and associated with more than 20 serious human diseases. We perform all-atom molecular dynamics simulations of amyloid fibril assembly and disassembly.

  2. Olefin Metathesis in Peptidomimetics, Dynamic Combinatorial Chemistry, and Molecular Imprinting

    National Research Council Canada - National Science Library

    Low, Tammy K

    2006-01-01

    .... Our research goals consisted of employing olefin metathesis in the synthesis of peptidomimetics, and studying the feasibility of this method in dynamic combinatorial chemistry and molecular imprinting of nerve agents...

  3. Modification of -Adenosyl--Homocysteine as Inhibitor of Nonstructural Protein 5 Methyltransferase Dengue Virus Through Molecular Docking and Molecular Dynamics Simulation

    Directory of Open Access Journals (Sweden)

    Usman Sumo Friend Tambunan

    2017-04-01

    Full Text Available Dengue fever is still a major threat worldwide, approximately threatening two-fifths of the world’s population in tropical and subtropical countries. Nonstructural protein 5 (NS5 methyltransferase enzyme plays a vital role in the process of messenger RNA capping of dengue by transferring methyl groups from S -adenosyl- l -methionine to N7 atom of the guanine bases of RNA and the RNA ribose group of 2′OH, resulting in S -adenosyl- l -homocysteine (SAH. The modification of SAH compound was screened using molecular docking and molecular dynamics simulation, along with computational ADME-Tox (absorption, distribution, metabolism, excretion, and toxicity test. The 2 simulations were performed using Molecular Operating Environment (MOE 2008.10 software, whereas the ADME-Tox test was performed using various software. The modification of SAH compound was done using several functional groups that possess different polarities and properties, resulting in 3460 ligands to be docked. After conducting docking simulation, we earned 3 best ligands (SAH-M331, SAH-M2696, and SAH-M1356 based on ΔG binding and molecular interactions, which show better results than the standard ligands. Moreover, the results of molecular dynamics simulation show that the best ligands are still able to maintain the active site residue interaction with the binding site until the end of the simulation. After a series of molecular docking and molecular dynamics simulation were performed, we concluded that SAH-M1356 ligand is the most potential SAH-based compound to inhibit NS5 methyltransferase enzyme for treating dengue fever.

  4. Molecular dynamics in high electric fields

    International Nuclear Information System (INIS)

    Apostol, M.; Cune, L.C.

    2016-01-01

    Highlights: • New method for rotation molecular spectra in high electric fields. • Parametric resonances – new features in spectra. • New elementary excitations in polar solids from dipolar interaction (“dipolons”). • Discussion about a possible origin of the ferroelectricity from dipolar interactions. - Abstract: Molecular rotation spectra, generated by the coupling of the molecular electric-dipole moments to an external time-dependent electric field, are discussed in a few particular conditions which can be of some experimental interest. First, the spherical-pendulum molecular model is reviewed, with the aim of introducing an approximate method which consists in the separation of the azimuthal and zenithal motions. Second, rotation spectra are considered in the presence of a static electric field. Two particular cases are analyzed, corresponding to strong and weak fields. In both cases the classical motion of the dipoles consists of rotations and vibrations about equilibrium positions; this motion may exhibit parametric resonances. For strong fields a large macroscopic electric polarization may appear. This situation may be relevant for polar matter (like pyroelectrics, ferroelectrics), or for heavy impurities embedded in a polar solid. The dipolar interaction is analyzed in polar condensed matter, where it is shown that new polarization modes appear for a spontaneous macroscopic electric polarization (these modes are tentatively called “dipolons”); one of the polarization modes is related to parametric resonances. The extension of these considerations to magnetic dipoles is briefly discussed. The treatment is extended to strong electric fields which oscillate with a high frequency, as those provided by high-power lasers. It is shown that the effect of such fields on molecular dynamics is governed by a much weaker, effective, renormalized, static electric field.

  5. Physical properties of Cu nanoparticles: A molecular dynamics study

    International Nuclear Information System (INIS)

    Kart, H.H.; Yildirim, H.; Ozdemir Kart, S.; Çağin, T.

    2014-01-01

    Thermodynamical, structural and dynamical properties of Cu nanoparticles are investigated by using Molecular Dynamics (MD) simulations at various temperatures. In this work, MD simulations of the Cu-nanoparticles are performed by means of the MPiSiM codes by utilizing from Quantum Sutton-Chen (Q-SC) many-body force potential to define the interactions between the Cu atoms. The diameters of the copper nanoparticles are varied from 2 nm to 10 nm. MD simulations of Cu nanoparticles are carried out at low and high temperatures to study solid and liquid properties of Cu nanoparticles. Simulation results such as melting point, radial distribution function are compared with the available experimental bulk results. Radial distribution function, mean square displacement, diffusion coefficient, Lindemann index and Honeycutt–Andersen index are also calculated for estimating the melting point of the Copper nanoparticles. - Highlights: • Solid and liquid properties of Cu nanoparticles are studied. • Molecular dynamics utilizing the Quantum Sutton Chen potential is used in this work. • Melting temperatures of nanoparticles are strongly depended on nanoparticle sizes. • Heat capacity, radial distribution function and diffusion coefficients are studied. • Structures of nanoparticles are analyzed by Lindemann and Honeycutt–Andersen index

  6. Huge-scale molecular dynamics simulation of multibubble nuclei

    KAUST Repository

    Watanabe, Hiroshi

    2013-12-01

    We have developed molecular dynamics codes for a short-range interaction potential that adopt both the flat-MPI and MPI/OpenMP hybrid parallelizations on the basis of a full domain decomposition strategy. Benchmark simulations involving up to 38.4 billion Lennard-Jones particles were performed on Fujitsu PRIMEHPC FX10, consisting of 4800 SPARC64 IXfx 1.848 GHz processors, at the Information Technology Center of the University of Tokyo, and a performance of 193 teraflops was achieved, which corresponds to a 17.0% execution efficiency. Cavitation processes were also simulated on PRIMEHPC FX10 and SGI Altix ICE 8400EX at the Institute of Solid State Physics of the University of Tokyo, which involved 1.45 billion and 22.9 million particles, respectively. Ostwald-like ripening was observed after the multibubble nuclei. Our results demonstrate that direct simulations of multiscale phenomena involving phase transitions from the atomic scale are possible and that the molecular dynamics method is a promising method that can be applied to petascale computers. © 2013 Elsevier B.V. All rights reserved.

  7. Molecular dynamics of the structure and thermodynamics of dusty ...

    African Journals Online (AJOL)

    The static structure and thermodynamic properties of two-dimensional dusty plasma are analyzed for some typical values of coupling and screening parameters using classical molecular dynamics. Radial distribution function and static structure factor are computed. The radial distribution functions display the typical ...

  8. An extended systematic mapping study about the scalability of i* Models

    Directory of Open Access Journals (Sweden)

    Paulo Lima

    2016-12-01

    Full Text Available i* models have been used for requirements specification in many domains, such as healthcare, telecommunication, and air traffic control. Managing the scalability and the complexity of such models is an important challenge in Requirements Engineering (RE. Scalability is also one of the most intractable issues in the design of visual notations in general: a well-known problem with visual representations is that they do not scale well. This issue has led us to investigate scalability in i* models and its variants by means of a systematic mapping study. This paper is an extended version of a previous paper on the scalability of i* including papers indicated by specialists. Moreover, we also discuss the challenges and open issues regarding scalability of i* models and its variants. A total of 126 papers were analyzed in order to understand: how the RE community perceives scalability; and which proposals have considered this topic. We found that scalability issues are indeed perceived as relevant and that further work is still required, even though many potential solutions have already been proposed. This study can be a starting point for researchers aiming to further advance the treatment of scalability in i* models.

  9. Scalable Nernst thermoelectric power using a coiled galfenol wire

    Science.gov (United States)

    Yang, Zihao; Codecido, Emilio A.; Marquez, Jason; Zheng, Yuanhua; Heremans, Joseph P.; Myers, Roberto C.

    2017-09-01

    The Nernst thermopower usually is considered far too weak in most metals for waste heat recovery. However, its transverse orientation gives it an advantage over the Seebeck effect on non-flat surfaces. Here, we experimentally demonstrate the scalable generation of a Nernst voltage in an air-cooled metal wire coiled around a hot cylinder. In this geometry, a radial temperature gradient generates an azimuthal electric field in the coil. A Galfenol (Fe0.85Ga0.15) wire is wrapped around a cartridge heater, and the voltage drop across the wire is measured as a function of axial magnetic field. As expected, the Nernst voltage scales linearly with the length of the wire. Based on heat conduction and fluid dynamic equations, finite-element method is used to calculate the temperature gradient across the Galfenol wire and determine the Nernst coefficient. A giant Nernst coefficient of -2.6 μV/KT at room temperature is estimated, in agreement with measurements on bulk Galfenol. We expect that the giant Nernst effect in Galfenol arises from its magnetostriction, presumably through enhanced magnon-phonon coupling. Our results demonstrate the feasibility of a transverse thermoelectric generator capable of scalable output power from non-flat heat sources.

  10. Scalable Nernst thermoelectric power using a coiled galfenol wire

    Directory of Open Access Journals (Sweden)

    Zihao Yang

    2017-09-01

    Full Text Available The Nernst thermopower usually is considered far too weak in most metals for waste heat recovery. However, its transverse orientation gives it an advantage over the Seebeck effect on non-flat surfaces. Here, we experimentally demonstrate the scalable generation of a Nernst voltage in an air-cooled metal wire coiled around a hot cylinder. In this geometry, a radial temperature gradient generates an azimuthal electric field in the coil. A Galfenol (Fe0.85Ga0.15 wire is wrapped around a cartridge heater, and the voltage drop across the wire is measured as a function of axial magnetic field. As expected, the Nernst voltage scales linearly with the length of the wire. Based on heat conduction and fluid dynamic equations, finite-element method is used to calculate the temperature gradient across the Galfenol wire and determine the Nernst coefficient. A giant Nernst coefficient of -2.6 μV/KT at room temperature is estimated, in agreement with measurements on bulk Galfenol. We expect that the giant Nernst effect in Galfenol arises from its magnetostriction, presumably through enhanced magnon-phonon coupling. Our results demonstrate the feasibility of a transverse thermoelectric generator capable of scalable output power from non-flat heat sources.

  11. Multiscale Molecular Dynamics Model for Heterogeneous Charged Systems

    Science.gov (United States)

    Stanton, L. G.; Glosli, J. N.; Murillo, M. S.

    2018-04-01

    Modeling matter across large length scales and timescales using molecular dynamics simulations poses significant challenges. These challenges are typically addressed through the use of precomputed pair potentials that depend on thermodynamic properties like temperature and density; however, many scenarios of interest involve spatiotemporal variations in these properties, and such variations can violate assumptions made in constructing these potentials, thus precluding their use. In particular, when a system is strongly heterogeneous, most of the usual simplifying assumptions (e.g., spherical potentials) do not apply. Here, we present a multiscale approach to orbital-free density functional theory molecular dynamics (OFDFT-MD) simulations that bridges atomic, interionic, and continuum length scales to allow for variations in hydrodynamic quantities in a consistent way. Our multiscale approach enables simulations on the order of micron length scales and 10's of picosecond timescales, which exceeds current OFDFT-MD simulations by many orders of magnitude. This new capability is then used to study the heterogeneous, nonequilibrium dynamics of a heated interface characteristic of an inertial-confinement-fusion capsule containing a plastic ablator near a fuel layer composed of deuterium-tritium ice. At these scales, fundamental assumptions of continuum models are explored; features such as the separation of the momentum fields among the species and strong hydrogen jetting from the plastic into the fuel region are observed, which had previously not been seen in hydrodynamic simulations.

  12. Lipid Configurations from Molecular Dynamics Simulations

    DEFF Research Database (Denmark)

    Pezeshkian, Weria; Khandelia, Himanshu; Marsh, Derek

    2018-01-01

    of dihedral angles in palmitoyl-oleoyl phosphatidylcholine from molecular dynamics simulations of hydrated fluid bilayer membranes. We compare results from the widely used lipid force field of Berger et al. with those from the most recent C36 release of the CHARMM force field for lipids. Only the CHARMM force......The extent to which current force fields faithfully reproduce conformational properties of lipids in bilayer membranes, and whether these reflect the structural principles established for phospholipids in bilayer crystals, are central to biomembrane simulations. We determine the distribution...

  13. Molecular dynamics studies of actinide nitrides

    International Nuclear Information System (INIS)

    Kurosaki, Ken; Uno, Masayoshi; Yamanaka, Shinsuke; Minato, Kazuo

    2004-01-01

    The molecular dynamics (MD) calculation was performed for actinide nitrides (UN, NpN, and PuN) in the temperature range from 300 to 2800 K to evaluate the physical properties viz., the lattice parameter, thermal expansion coefficient, compressibility, and heat capacity. The Morse-type potential function added to the Busing-Ida type potential was employed for the ionic interactions. The interatomic potential parameters were determined by fitting to the experimental data of the lattice parameter. The usefulness and applicability of the MD method to evaluate the physical properties of actinide nitrides were studied. (author)

  14. Molecular dynamics of surfactant protein C

    DEFF Research Database (Denmark)

    Ramírez, Eunice; Santana, Alberto; Cruz, Anthony

    2006-01-01

    Surfactant protein C (SP-C) is a membrane-associated protein essential for normal respiration. It has been found that the alpha-helix form of SP-C can undergo, under certain conditions, a transformation from an alpha-helix to a beta-strand conformation that closely resembles amyloid fibrils, which...... are possible contributors to the pathogenesis of pulmonary alveolar proteinosis. Molecular dynamics simulations using the NAMD2 package were performed for systems containing from one to seven SP-C molecules to study their behavior in water. The results of our simulations show that unfolding of the protein...

  15. Scalable Transactions for Web Applications in the Cloud

    NARCIS (Netherlands)

    Zhou, W.; Pierre, G.E.O.; Chi, C.-H.

    2009-01-01

    Cloud Computing platforms provide scalability and high availability properties for web applications but they sacrifice data consistency at the same time. However, many applications cannot afford any data inconsistency. We present a scalable transaction manager for NoSQL cloud database services to

  16. Temperature dependent dynamics of DegP-trimer: A molecular dynamics study

    Directory of Open Access Journals (Sweden)

    Nivedita Rai

    2015-01-01

    Full Text Available DegP is a heat shock protein from high temperature requirement protease A family, which reacts to the environmental stress conditions in an ATP independent way. The objective of the present analysis emerged from the temperature dependent functional diversity of DegP between chaperonic and protease activities at temperatures below and above 28 °C, respectively. DegP is a multimeric protein and the minimal functional unit, DegP-trimer, is of great importance in understanding the DegP pathway. The structural aspects of DegP-trimer with respect to temperature variation have been studied using molecular dynamics simulations (for 100 ns and principal component analysis to highlight the temperature dependent dynamics facilitating its functional diversity. The DegP-trimer revealed a pronounced dynamics at both 280 and 320 K, when compared to the dynamics observed at 300 K. The LA loop is identified as the highly flexible region during dynamics and at extreme temperatures, the residues 46–80 of LA loop express a flip towards right (at 280 and left ( at 320 K with respect to the fixed β-sheet connecting the LA loop of protease for which Phe46 acts as one of the key residues. Such dynamics of LA loop facilitates inter-monomeric interaction with the PDZ1 domain of the neighbouring monomer and explains its active participation when DegP exists as trimer. Hence, the LA loop mediated dynamics of DegP-trimer is expected to provide further insight into the temperature dependent dynamics of DegP towards the understanding of its assembly and functional diversity in the presence of substrate.

  17. Requirements for Scalable Access Control and Security Management Architectures

    National Research Council Canada - National Science Library

    Keromytis, Angelos D; Smith, Jonathan M

    2005-01-01

    Maximizing local autonomy has led to a scalable Internet. Scalability and the capacity for distributed control have unfortunately not extended well to resource access control policies and mechanisms...

  18. The dance of molecules: new dynamical perspectives on highly excited molecular vibrations.

    Science.gov (United States)

    Kellman, Michael E; Tyng, Vivian

    2007-04-01

    At low energies, molecular vibrational motion is described by the normal modes model. This model breaks down at higher energy, with strong coupling between normal modes and onset of chaotic dynamics. New anharmonic modes are born in bifurcations, or branchings of the normal modes. Knowledge of these new modes is obtained through the window of frequency-domain spectroscopy, using techniques of nonlinear classical dynamics. It may soon be possible to "watch" molecular rearrangement reactions spectroscopically. Connections are being made with reaction rate theories, condensed phase systems, and motions of electrons in quantum dots.

  19. Distance-Based Configurational Entropy of Proteins from Molecular Dynamics Simulations.

    Science.gov (United States)

    Fogolari, Federico; Corazza, Alessandra; Fortuna, Sara; Soler, Miguel Angel; VanSchouwen, Bryan; Brancolini, Giorgia; Corni, Stefano; Melacini, Giuseppe; Esposito, Gennaro

    2015-01-01

    Estimation of configurational entropy from molecular dynamics trajectories is a difficult task which is often performed using quasi-harmonic or histogram analysis. An entirely different approach, proposed recently, estimates local density distribution around each conformational sample by measuring the distance from its nearest neighbors. In this work we show this theoretically well grounded the method can be easily applied to estimate the entropy from conformational sampling. We consider a set of systems that are representative of important biomolecular processes. In particular: reference entropies for amino acids in unfolded proteins are obtained from a database of residues not participating in secondary structure elements;the conformational entropy of folding of β2-microglobulin is computed from molecular dynamics simulations using reference entropies for the unfolded state;backbone conformational entropy is computed from molecular dynamics simulations of four different states of the EPAC protein and compared with order parameters (often used as a measure of entropy);the conformational and rototranslational entropy of binding is computed from simulations of 20 tripeptides bound to the peptide binding protein OppA and of β2-microglobulin bound to a citrate coated gold surface. This work shows the potential of the method in the most representative biological processes involving proteins, and provides a valuable alternative, principally in the shown cases, where other approaches are problematic.

  20. Structural, dynamical, and electronic properties of amorphous silicon: An ab initio molecular dynamics study

    Energy Technology Data Exchange (ETDEWEB)

    Car, R.; Parrinello, M.

    1988-01-18

    An amorphous silicon structure is obtained with a computer simulation based on a new molecular-dynamics technique in which the interatomic potential is derived from a parameter-free quantum mechanical method. Our results for the atomic structure, the phonon spectrum, and the electronic properties are in excellent agreement with experiment. In addition we study details of the microscopic dynamics which are not directly accessible to experiment. We find in particular that structural defects are associated with weak bonds. These may give rise to low-frequency vibrational modes.

  1. Control of the dynamics of coupled atomic-molecular Bose-Einstein condensates: Modified Gross-Pitaevskii approach

    International Nuclear Information System (INIS)

    Gupta, Moumita; Dastidar, Krishna Rai

    2009-01-01

    We study the dynamics of the atomic and molecular Bose-Einstein condensates (BECs) of 87 Rb in a spherically symmetric trap coupled by stimulated Raman photoassociation process. Considering the higher order nonlinearity in the atom-atom interaction we analyze the dynamics of the system using coupled modified Gross-Pitaevskii (MGP) equations and compare it with mean-field coupled Gross-Pitaevskii (GP) dynamics. Considerable differences in the dynamics are obtained in these two approaches at large scattering length, i.e., for large values of peak-gas parameter x pk ≥10 -3 . We show how the dynamics of the coupled system is affected when the atom-molecule and molecule-molecule interactions are considered together with the atom-atom interaction and also when the strengths of these three interactions are increased. The effect of detuning on the efficiency of conversion of atomic fractions into molecules is demonstrated and the feasibility of maximum molecular BEC formation by varying the Raman detuning parameter at different values of time is explored. Thus by varying the Raman detuning and the scattering length for atom-atom interaction one can control the dynamics of the coupled atomic-molecular BEC system. We have also solved coupled Gross-Pitaevskii equations for atomic to molecular condensate formation through magnetic Feshbach resonance in a BEC of 85 Rb. We found similar features for oscillations between atomic and molecular condensates noted in previous theoretical study and obtained fairly good agreement with the evolution of total atomic condensate observed experimentally.

  2. A scalable and practical one-pass clustering algorithm for recommender system

    Science.gov (United States)

    Khalid, Asra; Ghazanfar, Mustansar Ali; Azam, Awais; Alahmari, Saad Ali

    2015-12-01

    KMeans clustering-based recommendation algorithms have been proposed claiming to increase the scalability of recommender systems. One potential drawback of these algorithms is that they perform training offline and hence cannot accommodate the incremental updates with the arrival of new data, making them unsuitable for the dynamic environments. From this line of research, a new clustering algorithm called One-Pass is proposed, which is a simple, fast, and accurate. We show empirically that the proposed algorithm outperforms K-Means in terms of recommendation and training time while maintaining a good level of accuracy.

  3. Molecular dynamics study of the silica-water-SDA interactions

    NARCIS (Netherlands)

    Szyja, B.M.; Jansen, A.P.J.; Verstraelen, T.; Santen, van R.A.

    2009-01-01

    In this paper we have applied the molecular dynamics simulations in order to analyse the role of the structure directing tetrapropylammonium ions in the aggregation process that leads to silicalite formation. We address the specific question of how the interactions between silica precursor species

  4. Scalable cloud without dedicated storage

    Science.gov (United States)

    Batkovich, D. V.; Kompaniets, M. V.; Zarochentsev, A. K.

    2015-05-01

    We present a prototype of a scalable computing cloud. It is intended to be deployed on the basis of a cluster without the separate dedicated storage. The dedicated storage is replaced by the distributed software storage. In addition, all cluster nodes are used both as computing nodes and as storage nodes. This solution increases utilization of the cluster resources as well as improves fault tolerance and performance of the distributed storage. Another advantage of this solution is high scalability with a relatively low initial and maintenance cost. The solution is built on the basis of the open source components like OpenStack, CEPH, etc.

  5. Ancestors protocol for scalable key management

    Directory of Open Access Journals (Sweden)

    Dieter Gollmann

    2010-06-01

    Full Text Available Group key management is an important functional building block for secure multicast architecture. Thereby, it has been extensively studied in the literature. The main proposed protocol is Adaptive Clustering for Scalable Group Key Management (ASGK. According to ASGK protocol, the multicast group is divided into clusters, where each cluster consists of areas of members. Each cluster uses its own Traffic Encryption Key (TEK. These clusters are updated periodically depending on the dynamism of the members during the secure session. The modified protocol has been proposed based on ASGK with some modifications to balance the number of affected members and the encryption/decryption overhead with any number of the areas when a member joins or leaves the group. This modified protocol is called Ancestors protocol. According to Ancestors protocol, every area receives the dynamism of the members from its parents. The main objective of the modified protocol is to reduce the number of affected members during the leaving and joining members, then 1 affects n overhead would be reduced. A comparative study has been done between ASGK protocol and the modified protocol. According to the comparative results, it found that the modified protocol is always outperforming the ASGK protocol.

  6. Machine learning molecular dynamics for the simulation of infrared spectra.

    Science.gov (United States)

    Gastegger, Michael; Behler, Jörg; Marquetand, Philipp

    2017-10-01

    Machine learning has emerged as an invaluable tool in many research areas. In the present work, we harness this power to predict highly accurate molecular infrared spectra with unprecedented computational efficiency. To account for vibrational anharmonic and dynamical effects - typically neglected by conventional quantum chemistry approaches - we base our machine learning strategy on ab initio molecular dynamics simulations. While these simulations are usually extremely time consuming even for small molecules, we overcome these limitations by leveraging the power of a variety of machine learning techniques, not only accelerating simulations by several orders of magnitude, but also greatly extending the size of systems that can be treated. To this end, we develop a molecular dipole moment model based on environment dependent neural network charges and combine it with the neural network potential approach of Behler and Parrinello. Contrary to the prevalent big data philosophy, we are able to obtain very accurate machine learning models for the prediction of infrared spectra based on only a few hundreds of electronic structure reference points. This is made possible through the use of molecular forces during neural network potential training and the introduction of a fully automated sampling scheme. We demonstrate the power of our machine learning approach by applying it to model the infrared spectra of a methanol molecule, n -alkanes containing up to 200 atoms and the protonated alanine tripeptide, which at the same time represents the first application of machine learning techniques to simulate the dynamics of a peptide. In all of these case studies we find an excellent agreement between the infrared spectra predicted via machine learning models and the respective theoretical and experimental spectra.

  7. MOLECULAR DYNAMICS COMPUTER SIMULATIONS OF MULTIDRUG RND EFFLUX PUMPS

    Directory of Open Access Journals (Sweden)

    Paolo Ruggerone

    2013-02-01

    Full Text Available Over-expression of multidrug efflux pumps of the Resistance Nodulation Division (RND protein super family counts among the main causes for microbial resistance against pharmaceuticals. Understanding the molecular basis of this process is one of the major challenges of modern biomedical research, involving a broad range of experimental and computational techniques. Here we review the current state of RND transporter investigation employing molecular dynamics simulations providing conformational samples of transporter components to obtain insights into the functional mechanism underlying efflux pump-mediated antibiotics resistance in Escherichia coli and Pseudomonas aeruginosa.

  8. Molecular Dynamics Computer Simulations of Multidrug RND Efflux Pumps

    Directory of Open Access Journals (Sweden)

    Paolo Ruggerone

    2013-02-01

    Full Text Available Over-expression of multidrug efflux pumps of the Resistance Nodulation Division (RND protein super family counts among the main causes for microbial resistance against pharmaceuticals. Understanding the molecular basis of this process is one of the major challenges of modern biomedical research, involving a broad range of experimental and computational techniques. Here we review the current state of RND transporter investigation employing molecular dynamics simulations providing conformational samples of transporter components to obtain insights into the functional mechanism underlying efflux pump-mediated antibiotics resistance in Escherichia coli and Pseudomonas aeruginosa.

  9. Investigation of nuclear multifragmentation using molecular dynamics and restructured aggregation

    International Nuclear Information System (INIS)

    Paula, L. de; Nemeth, J.; Ben-Hao, Sa.; Leray, S.; Ngo, C.; Souza, S.R.; Yu-Ming, Zheng; Paula, L. de; Nemeth, J.; Ben-Hao, Sa.; Yu-Ming, Zheng; Ngo, H.

    1991-01-01

    We study the stability of excited 197 Au nuclei with respect to multifragmentation. For that we use a dynamical simulation based on molecular dynamics and restructured aggregation. A particular attention is paid to check the stability of the ground state nuclei generated by the simulation. Four kinds of excitations are considered: heat, compression, rotation and a geometrical instability created when a projectile drills a hole in a 197 Au nucleus

  10. Accelerated molecular dynamics methods: introduction and recent developments

    Energy Technology Data Exchange (ETDEWEB)

    Uberuaga, Blas Pedro [Los Alamos National Laboratory; Voter, Arthur F [Los Alamos National Laboratory; Perez, Danny [Los Alamos National Laboratory; Shim, Y [UNIV OF TOLEDO; Amar, J G [UNIV OF TOLEDO

    2009-01-01

    A long-standing limitation in the use of molecular dynamics (MD) simulation is that it can only be applied directly to processes that take place on very short timescales: nanoseconds if empirical potentials are employed, or picoseconds if we rely on electronic structure methods. Many processes of interest in chemistry, biochemistry, and materials science require study over microseconds and beyond, due either to the natural timescale for the evolution or to the duration of the experiment of interest. Ignoring the case of liquids xxx, the dynamics on these time scales is typically characterized by infrequent-event transitions, from state to state, usually involving an energy barrier. There is a long and venerable tradition in chemistry of using transition state theory (TST) [10, 19, 23] to directly compute rate constants for these kinds of activated processes. If needed dynamical corrections to the TST rate, and even quantum corrections, can be computed to achieve an accuracy suitable for the problem at hand. These rate constants then allow them to understand the system behavior on longer time scales than we can directly reach with MD. For complex systems with many reaction paths, the TST rates can be fed into a stochastic simulation procedure such as kinetic Monte Carlo xxx, and a direct simulation of the advance of the system through its possible states can be obtained in a probabilistically exact way. A problem that has become more evident in recent years, however, is that for many systems of interest there is a complexity that makes it difficult, if not impossible, to determine all the relevant reaction paths to which TST should be applied. This is a serious issue, as omitted transition pathways can have uncontrollable consequences on the simulated long-time kinetics. Over the last decade or so, we have been developing a new class of methods for treating the long-time dynamics in these complex, infrequent-event systems. Rather than trying to guess in advance what

  11. Accelerated molecular dynamics methods: introduction and recent developments

    International Nuclear Information System (INIS)

    Uberuaga, Blas Pedro; Voter, Arthur F.; Perez, Danny; Shim, Y.; Amar, J.G.

    2009-01-01

    A long-standing limitation in the use of molecular dynamics (MD) simulation is that it can only be applied directly to processes that take place on very short timescales: nanoseconds if empirical potentials are employed, or picoseconds if we rely on electronic structure methods. Many processes of interest in chemistry, biochemistry, and materials science require study over microseconds and beyond, due either to the natural timescale for the evolution or to the duration of the experiment of interest. Ignoring the case of liquids xxx, the dynamics on these time scales is typically characterized by infrequent-event transitions, from state to state, usually involving an energy barrier. There is a long and venerable tradition in chemistry of using transition state theory (TST) (10, 19, 23) to directly compute rate constants for these kinds of activated processes. If needed dynamical corrections to the TST rate, and even quantum corrections, can be computed to achieve an accuracy suitable for the problem at hand. These rate constants then allow them to understand the system behavior on longer time scales than we can directly reach with MD. For complex systems with many reaction paths, the TST rates can be fed into a stochastic simulation procedure such as kinetic Monte Carlo xxx, and a direct simulation of the advance of the system through its possible states can be obtained in a probabilistically exact way. A problem that has become more evident in recent years, however, is that for many systems of interest there is a complexity that makes it difficult, if not impossible, to determine all the relevant reaction paths to which TST should be applied. This is a serious issue, as omitted transition pathways can have uncontrollable consequences on the simulated long-time kinetics. Over the last decade or so, we have been developing a new class of methods for treating the long-time dynamics in these complex, infrequent-event systems. Rather than trying to guess in advance what

  12. Statistical ensembles and molecular dynamics studies of anisotropic solids. II

    International Nuclear Information System (INIS)

    Ray, J.R.; Rahman, A.

    1985-01-01

    We have recently discussed how the Parrinello--Rahman theory can be brought into accord with the theory of the elastic and thermodynamic behavior of anisotropic media. This involves the isoenthalpic--isotension ensemble of statistical mechanics. Nose has developed a canonical ensemble form of molecular dynamics. We combine Nose's ideas with the Parrinello--Rahman theory to obtain a canonical form of molecular dynamics appropriate to the study of anisotropic media subjected to arbitrary external stress. We employ this isothermal--isotension ensemble in a study of a fcc→ close-packed structural phase transformation in a Lennard-Jones solid subjected to uniaxial compression. Our interpretation of the Nose theory does not involve a scaling of the time variable. This latter fact leads to simplifications when studying the time dependence of quantities

  13. Temperature specification in atomistic molecular dynamics and its impact on simulation efficacy

    Science.gov (United States)

    Ocaya, R. O.; Terblans, J. J.

    2017-10-01

    Temperature is a vital thermodynamical function for physical systems. Knowledge of system temperature permits assessment of system ergodicity, entropy, system state and stability. Rapid theoretical and computational developments in the fields of condensed matter physics, chemistry, material science, molecular biology, nanotechnology and others necessitate clarity in the temperature specification. Temperature-based materials simulations, both standalone and distributed computing, are projected to grow in prominence over diverse research fields. In this article we discuss the apparent variability of temperature modeling formalisms used currently in atomistic molecular dynamics simulations, with respect to system energetics,dynamics and structural evolution. Commercial simulation programs, which by nature are heuristic, do not openly discuss this fundamental question. We address temperature specification in the context of atomistic molecular dynamics. We define a thermostat at 400K relative to a heat bath at 300K firstly using a modified ab-initio Newtonian method, and secondly using a Monte-Carlo method. The thermostatic vacancy formation and cohesion energies, equilibrium lattice constant for FCC copper is then calculated. Finally we compare and contrast the results.

  14. Reliable Approximation of Long Relaxation Timescales in Molecular Dynamics

    Directory of Open Access Journals (Sweden)

    Wei Zhang

    2017-07-01

    Full Text Available Many interesting rare events in molecular systems, like ligand association, protein folding or conformational changes, occur on timescales that often are not accessible by direct numerical simulation. Therefore, rare event approximation approaches like interface sampling, Markov state model building, or advanced reaction coordinate-based free energy estimation have attracted huge attention recently. In this article we analyze the reliability of such approaches. How precise is an estimate of long relaxation timescales of molecular systems resulting from various forms of rare event approximation methods? Our results give a theoretical answer to this question by relating it with the transfer operator approach to molecular dynamics. By doing so we also allow for understanding deep connections between the different approaches.

  15. Molecular Dynamics Approach in Designing Thermostable Aspergillus niger Xylanase

    Science.gov (United States)

    Malau, N. D.; Sianturi, M.

    2017-03-01

    Molecular dynamics methods we have applied as a tool in designing thermostable Aspergillus niger Xylanase, by examining Root Mean Square Deviation (RMSD) and The Stability of the Secondary Structure of enzymes structure at its optimum temperature and compare with its high temperature behavior. As RMSD represents structural fluctuation at a particular temperature, a better understanding of this factor will suggest approaches to bioengineer these enzymes to enhance their thermostability. In this work molecular dynamic simulations of Aspergillus niger xylanase (ANX) have been carried at 400K (optimum catalytic temperature) for 2.5 ns and 500K (ANX reported inactive temperature) for 2.5 ns. Analysis have shown that the Root Mean Square Deviation (RMSD) significant increase at higher temperatures compared at optimum temperature and some of the secondary structures of ANX that have been damaged at high temperature. Structural analysis revealed that the fluctuations of the α-helix and β-sheet regions are larger at higher temperatures compared to the fluctuations at optimum temperature.

  16. A new parallel molecular dynamics algorithm for organic systems

    International Nuclear Information System (INIS)

    Plimpton, S.; Hendrickson, B.; Heffelfinger, G.

    1993-01-01

    A new parallel algorithm for simulating bonded molecular systems such as polymers and proteins by molecular dynamics (MD) is presented. In contrast to methods that extract parallelism by breaking the spatial domain into sub-pieces, the new method does not require regular geometries or uniform particle densities to achieve high parallel efficiency. For very large, regular systems spatial methods are often the best choice, but in practice the new method is faster for systems with tens-of-thousands of atoms simulated on large numbers of processors. It is also several times faster than the techniques commonly used for parallelizing bonded MD that assign a subset of atoms to each processor and require all-to-all communication. Implementation of the algorithm in a CHARMm-like MD model with many body forces and constraint dynamics is discussed and timings on the Intel Delta and Paragon machines are given. Example calculations using the algorithm in simulations of polymers and liquid-crystal molecules will also be briefly discussed

  17. Molecular Dynamics Simulations of displacement cascades in metallic systems

    International Nuclear Information System (INIS)

    Doan, N.V.; Tietze, H.

    1995-01-01

    We use Molecular Dynamics Computer Simulations to investigate defect production induced by energetic displacement cascades up to 10 keV in pure metals (Cu, Ni) and in ordered intermetallic alloys NiAl, Ni 3 Al. Various model potentials were employed to describe the many-body nature of the interactions: the RGL (Rosato-Guillope-Legrand) model was used in pure Cu and Ni simulations; the modified version of the Vitek, Ackland and Cserti potentials (due to Gao, Bacon and Ackland) in Ni 3 Al and the EAM potentials of Foiles and Daw modified by Rubini and Ballone in NiAl, Ni 3 Al were used in alloy simulations. Atomic mixing and disordering were studied into details owing to imaging techniques and determined at different phases of the cascades. Some mixing mechanisms were identified. Our results were compared with existing data and those obtained by similar Molecular Dynamics Simulations available in the literature. (orig.)

  18. Ultrafast dissociation: An unexpected tool for probing molecular dynamics

    International Nuclear Information System (INIS)

    Morin, Paul; Miron, Catalin

    2012-01-01

    Highlights: ► Ultrafast dissociation has been investigated by means of XPS and mass spectrometry. ► The interplay between electron relaxation and molecular dynamics is evidenced. ► Extension toward polyatomics, clusters, adsorbed molecules is considered. ► Quantum effects (spectral hole, angular effects) evidence the molecular field anisotropy. -- Abstract: Ultrafast dissociation following core–shell excitation into an antibonding orbital led to the early observation in HBr of atomic Auger lines associated to the decay of dissociated excited atoms. The purpose of this article is to review the very large variety of systems where such a situation has been encountered, extending from simple diatomic molecules toward more complex systems like polyatomics, clusters, or adsorbed molecules. Interestingly, this phenomenon has revealed an extremely rich and powerful tool for probing nuclear dynamics and its subtle interplay with electron relaxation occurring on a comparable time scale. Consequently this review covers a surprisingly large period, starting in 1986 and still ongoing.

  19. Dynamic neutron scattering from conformational dynamics. II. Application using molecular dynamics simulation and Markov modeling.

    Science.gov (United States)

    Yi, Zheng; Lindner, Benjamin; Prinz, Jan-Hendrik; Noé, Frank; Smith, Jeremy C

    2013-11-07

    Neutron scattering experiments directly probe the dynamics of complex molecules on the sub pico- to microsecond time scales. However, the assignment of the relaxations seen experimentally to specific structural rearrangements is difficult, since many of the underlying dynamical processes may exist on similar timescales. In an accompanying article, we present a theoretical approach to the analysis of molecular dynamics simulations with a Markov State Model (MSM) that permits the direct identification of structural transitions leading to each contributing relaxation process. Here, we demonstrate the use of the method by applying it to the configurational dynamics of the well-characterized alanine dipeptide. A practical procedure for deriving the MSM from an MD is introduced. The result is a 9-state MSM in the space of the backbone dihedral angles and the side-chain methyl group. The agreement between the quasielastic spectrum calculated directly from the atomic trajectories and that derived from the Markov state model is excellent. The dependence on the wavevector of the individual Markov processes is described. The procedure means that it is now practicable to interpret quasielastic scattering spectra in terms of well-defined intramolecular transitions with minimal a priori assumptions as to the nature of the dynamics taking place.

  20. The structure of molecular liquids. Neutron diffraction and molecular dynamics simulations

    International Nuclear Information System (INIS)

    Bianchi, L.

    2000-05-01

    Neutron diffraction (ND) measurements on liquid methanol (CD 3 OD, CD 3 O(H/D), CD 3 OH) under ambient conditions were performed to obtain the distinct (intra- + inter-molecular), G dist (r) and inter-molecular, G inter (r) radial distribution functions (rdfs) for the three samples. The H/D substitution on hydroxyl-hydrogen (Ho) has been used to extract the partial distribution functions, G XHo (r) (X=C, O, and H - a methyl hydrogen) and G XX (r) at both the distinct and inter-molecular levels from the difference techniques of ND. The O-Ho bond length, which has been the subject of controversy in the past, is found purely from the distinct partial distribution function, G XHo (r) to be 0.98 ± 0.01 A. The C-H distance obtained from the distinct G XX (r) partial is 1.08 ± 0.01 A. These distances determined by fitting an intra-molecular model to the total distinct structure functions are 0.961 ± 0.001 A and 1.096 ± 0.001 A, respectively. The inter-molecular G XX (r) function, dominated by contributions from the methyl groups, apart from showing broad oscillations extending up to ∼14 A is featureless, mainly because of cancellation effects from six contributing pairs. The Ho-Ho partial pair distribution function (pdf), g HoHo (r), determined from the second order difference, shows that only one other Ho atom can be found within a mean Ho-Ho separation of 2.36 A. The average position of the O-Ho hydrogen bond determined for the first time purely from experimental inter-molecular G XHo (r) partial distribution function is found to be at 1.75 ± 0.03 A. The experimental structural results at the partial distribution level are compared with those obtained from molecular dynamics (MD) simulations performed in NVE ensemble by using both 3- and 6-site force field models for the first time in this study. The MD simulations with both the models reproduce the ND rdfs rather well. However, discrepancies begin to appear between the simulated and the experimental partial

  1. Molecular beam studies of reaction dynamics

    International Nuclear Information System (INIS)

    Lee, Yuan T.

    1991-03-01

    The major thrust of this research project is to elucidate detailed dynamics of simple elementary reactions that are theoretically important and to unravel the mechanism of complex chemical reactions or photochemical processes that play important roles in many macroscopic processes. Molecular beams of reactants are used to study individual reactive encounters between molecules or to monitor photodissociation events in a collision-free environment. Most of the information is derived from measurement of the product fragment energy, angular, and state distributions. Recent activities are centered on the mechanisms of elementary chemical reactions involving oxygen atoms with unsaturated hydrocarbons, the dynamics of endothermic substitution reactions, the dependence of the chemical reactivity of electronically excited atoms on the alignment of excited orbitals, the primary photochemical processes of polyatomic molecules, intramolecular energy transfer of chemically activated and locally excited molecules, the energetics of free radicals that are important to combustion processes, the infrared-absorption spectra of carbonium ions and hydrated hydronium ions, and bond-selective photodissociation through electric excitation

  2. Molecular beam studies of reaction dynamics

    Energy Technology Data Exchange (ETDEWEB)

    Lee, Y.T. [Lawrence Berkeley Laboratory, CA (United States)

    1993-12-01

    The major thrust of this research project is to elucidate detailed dynamics of simple elementary reactions that are theoretically important and to unravel the mechanism of complex chemical reactions or photochemical processes that play important roles in many macroscopic processes. Molecular beams of reactants are used to study individual reactive encounters between molecules or to monitor photodissociation events in a collision-free environment. Most of the information is derived from measurement of the product fragment energy, angular, and state distributions. Recent activities are centered on the mechanisms of elementary chemical reactions involving oxygen atoms with unsaturated hydrocarbons, the dynamics of endothermic substitution reactions, the dependence of the chemical reactivity of electronically excited atoms on the alignment of excited orbitals, the primary photochemical processes of polyatomic molecules, intramolecular energy transfer of chemically activated and locally excited molecules, the energetics of free radicals that are important to combustion processes, the infrared-absorption spectra of carbonium ions and hydrated hydronium ions, and bond-selective photodissociation through electric excitation.

  3. A molecular dynamics calculation of solid phase of malonic acid ...

    Indian Academy of Sciences (India)

    Sathya S R R Perumal

    Keywords. Hydrogen bond chain; elastic constants; molecular dynamics. 1. Introduction ... theory - a probabilistic model to determine the hydro- gen bonds within the .... compares poorly with the experimental value of 108.5. Similarly β and γ ...

  4. On the molecular dynamics in the hurricane interactions with its environment

    Science.gov (United States)

    Meyer, Gabriel; Vitiello, Giuseppe

    2018-06-01

    By resorting to the Burgers model for hurricanes, we study the molecular motion involved in the hurricane dynamics. We show that the Lagrangian canonical formalism requires the inclusion of the environment degrees of freedom. This also allows the description of the motion of charged particles. In view of the role played by moist convection, cumulus and cloud water droplets in the hurricane dynamics, we discuss on the basis of symmetry considerations the role played by the molecular electrical dipoles and the formation of topologically non-trivial structures. The mechanism of energy storage and dissipation, the non-stationary time dependent Ginzburg-Landau equation and the vortex equation are studied. Finally, we discuss the fractal self-similarity properties of hurricanes.

  5. Molecular Structural Transformation of 2:1 Clay Minerals by a Constant-Pressure Molecular Dynamics Simulation Method

    International Nuclear Information System (INIS)

    Wang, J.; Gutierre, M.S.

    2010-01-01

    This paper presents results of a molecular dynamics simulation study of dehydrated 2:1 clay minerals using the Parrinello-Rahman constant-pressure molecular dynamics method. The method is capable of simulating a system under the most general applied stress conditions by considering the changes of MD cell size and shape. Given the advantage of the method, it is the major goal of the paper to investigate the influence of imposed cell boundary conditions on the molecular structural transformation of 2:1 clay minerals under different normal pressures. Simulation results show that the degrees of freedom of the simulation cell (i.e., whether the cell size or shape change is allowed) determines the final equilibrated crystal structure of clay minerals. Both the MD method and the static method have successfully revealed unforeseen structural transformations of clay minerals upon relaxation under different normal pressures. It is found that large shear distortions of clay minerals occur when full allowance is given to the cell size and shape change. A complete elimination of the interlayer spacing is observed in a static simulation. However, when only the cell size change is allowed, interlayer spacing is retained, but large internal shear stresses also exist.

  6. Theoretical study of molecular vibrations in electron momentum spectroscopy experiments on furan: An analytical versus a molecular dynamical approach

    International Nuclear Information System (INIS)

    Morini, Filippo; Deleuze, Michael S.; Watanabe, Noboru; Takahashi, Masahiko

    2015-01-01

    The influence of thermally induced nuclear dynamics (molecular vibrations) in the initial electronic ground state on the valence orbital momentum profiles of furan has been theoretically investigated using two different approaches. The first of these approaches employs the principles of Born-Oppenheimer molecular dynamics, whereas the so-called harmonic analytical quantum mechanical approach resorts to an analytical decomposition of contributions arising from quantized harmonic vibrational eigenstates. In spite of their intrinsic differences, the two approaches enable consistent insights into the electron momentum distributions inferred from new measurements employing electron momentum spectroscopy and an electron impact energy of 1.2 keV. Both approaches point out in particular an appreciable influence of a few specific molecular vibrations of A 1 symmetry on the 9a 1 momentum profile, which can be unravelled from considerations on the symmetry characteristics of orbitals and their energy spacing

  7. Metal cluster fission: jellium model and Molecular dynamics simulations

    DEFF Research Database (Denmark)

    Lyalin, Andrey G.; Obolensky, Oleg I.; Solov'yov, Ilia

    2004-01-01

    Fission of doubly charged sodium clusters is studied using the open-shell two-center deformed jellium model approximation and it ab initio molecular dynamic approach accounting for all electrons in the system. Results of calculations of fission reactions Na_10^2+ --> Na_7^+ + Na_3^+ and Na_18...

  8. Probing the Structure and Dynamics of Proteins by Combining Molecular Dynamics Simulations and Experimental NMR Data.

    Science.gov (United States)

    Allison, Jane R; Hertig, Samuel; Missimer, John H; Smith, Lorna J; Steinmetz, Michel O; Dolenc, Jožica

    2012-10-09

    NMR experiments provide detailed structural information about biological macromolecules in solution. However, the amount of information obtained is usually much less than the number of degrees of freedom of the macromolecule. Moreover, the relationships between experimental observables and structural information, such as interatomic distances or dihedral angle values, may be multiple-valued and may rely on empirical parameters and approximations. The extraction of structural information from experimental data is further complicated by the time- and ensemble-averaged nature of NMR observables. Combining NMR data with molecular dynamics simulations can elucidate and alleviate some of these problems, as well as allow inconsistencies in the NMR data to be identified. Here, we use a number of examples from our work to highlight the power of molecular dynamics simulations in providing a structural interpretation of solution NMR data.

  9. Rheology of liquid n-triacontane: Molecular dynamics simulation

    International Nuclear Information System (INIS)

    Kondratyuk, N D; Norman, G E; Stegailov, V V

    2016-01-01

    Molecular dynamics is applied to calculate diffusion coefficients of n-triacontane C 30 H 62 using Einstein-Smoluchowski and Green-Kubo relations. The displacement 〈Δr 2 〉( t ) has a subdiffusive part 〈Δr 2 〉 ∼ t α , caused by molecular crowding at low temperatures. Longtime asymptotes of 〈v(0)v(t)〉 are collated with the hydrodynamic tail t -3/2 demonstrated for atomic liquids. The influence of these asymptotes on the compliance of Einstein-Smoluchowski and Green-Kubo methods is analyzed. The effects of the force field parameters on the diffusion process are treated. The results are compared with experimental data. (paper)

  10. A comparison of molecular dynamics and diffuse interface model predictions of Lennard-Jones fluid evaporation

    Energy Technology Data Exchange (ETDEWEB)

    Barbante, Paolo [Dipartimento di Matematica, Politecnico di Milano - Piazza Leonardo da Vinci 32 - 20133 Milano (Italy); Frezzotti, Aldo; Gibelli, Livio [Dipartimento di Scienze e Tecnologie Aerospaziali, Politecnico di Milano - Via La Masa 34 - 20156 Milano (Italy)

    2014-12-09

    The unsteady evaporation of a thin planar liquid film is studied by molecular dynamics simulations of Lennard-Jones fluid. The obtained results are compared with the predictions of a diffuse interface model in which capillary Korteweg contributions are added to hydrodynamic equations, in order to obtain a unified description of the liquid bulk, liquid-vapor interface and vapor region. Particular care has been taken in constructing a diffuse interface model matching the thermodynamic and transport properties of the Lennard-Jones fluid. The comparison of diffuse interface model and molecular dynamics results shows that, although good agreement is obtained in equilibrium conditions, remarkable deviations of diffuse interface model predictions from the reference molecular dynamics results are observed in the simulation of liquid film evaporation. It is also observed that molecular dynamics results are in good agreement with preliminary results obtained from a composite model which describes the liquid film by a standard hydrodynamic model and the vapor by the Boltzmann equation. The two mathematical model models are connected by kinetic boundary conditions assuming unit evaporation coefficient.

  11. Rapid and Scalable Characterization of CRISPR Technologies Using an E. coli Cell-Free Transcription-Translation System.

    Science.gov (United States)

    Marshall, Ryan; Maxwell, Colin S; Collins, Scott P; Jacobsen, Thomas; Luo, Michelle L; Begemann, Matthew B; Gray, Benjamin N; January, Emma; Singer, Anna; He, Yonghua; Beisel, Chase L; Noireaux, Vincent

    2018-01-04

    CRISPR-Cas systems offer versatile technologies for genome engineering, yet their implementation has been outpaced by ongoing discoveries of new Cas nucleases and anti-CRISPR proteins. Here, we present the use of E. coli cell-free transcription-translation (TXTL) systems to vastly improve the speed and scalability of CRISPR characterization and validation. TXTL can express active CRISPR machinery from added plasmids and linear DNA, and TXTL can output quantitative dynamics of DNA cleavage and gene repression-all without protein purification or live cells. We used TXTL to measure the dynamics of DNA cleavage and gene repression for single- and multi-effector CRISPR nucleases, predict gene repression strength in E. coli, determine the specificities of 24 diverse anti-CRISPR proteins, and develop a fast and scalable screen for protospacer-adjacent motifs that was successfully applied to five uncharacterized Cpf1 nucleases. These examples underscore how TXTL can facilitate the characterization and application of CRISPR technologies across their many uses. Copyright © 2017 Elsevier Inc. All rights reserved.

  12. Enhancing Scalability of Sparse Direct Methods

    International Nuclear Information System (INIS)

    Li, Xiaoye S.; Demmel, James; Grigori, Laura; Gu, Ming; Xia, Jianlin; Jardin, Steve; Sovinec, Carl; Lee, Lie-Quan

    2007-01-01

    TOPS is providing high-performance, scalable sparse direct solvers, which have had significant impacts on the SciDAC applications, including fusion simulation (CEMM), accelerator modeling (COMPASS), as well as many other mission-critical applications in DOE and elsewhere. Our recent developments have been focusing on new techniques to overcome scalability bottleneck of direct methods, in both time and memory. These include parallelizing symbolic analysis phase and developing linear-complexity sparse factorization methods. The new techniques will make sparse direct methods more widely usable in large 3D simulations on highly-parallel petascale computers

  13. Viscosity calculations at molecular dynamics simulations

    International Nuclear Information System (INIS)

    Kirova, E M; Norman, G E

    2015-01-01

    Viscosity and diffusion are chosen as an example to demonstrate the universality of diagnostics methods in the molecular dynamics method. To emphasize the universality, three diverse systems are investigated, which differ from each other drastically: liquids with embedded atom method and pairwise interatomic interaction potentials and dusty plasma with a unique multiparametric interparticle interaction potential. Both the Einstein-Helfand and Green-Kubo relations are used. Such a particular process as glass transition is analysed at the simulation of the aluminium melt. The effect of the dust particle charge fluctuation is considered. The results are compared with the experimental data. (paper)

  14. Modular Universal Scalable Ion-trap Quantum Computer

    Science.gov (United States)

    2016-06-02

    SECURITY CLASSIFICATION OF: The main goal of the original MUSIQC proposal was to construct and demonstrate a modular and universally- expandable ion...Distribution Unlimited UU UU UU UU 02-06-2016 1-Aug-2010 31-Jan-2016 Final Report: Modular Universal Scalable Ion-trap Quantum Computer The views...P.O. Box 12211 Research Triangle Park, NC 27709-2211 Ion trap quantum computation, scalable modular architectures REPORT DOCUMENTATION PAGE 11

  15. Three-stage classical molecular dynamics model for simulation of heavy-ion fusion

    Directory of Open Access Journals (Sweden)

    Godre Subodh S.

    2015-01-01

    Full Text Available A three-stage Classical Molecular Dynamics (3S-CMD approach for heavy-ion fusion is developed. In this approach the Classical Rigid-Body Dynamics simulation for heavy-ion collision involving light deformed nucleus is initiated on their Rutherford trajectories at very large initial separation. Collision simulation is then followed by relaxation of the rigid-body constrains for one or both the colliding nuclei at distances close to the barrier when the trajectories of all the nucleons are obtained in a Classical Molecular Dynamics approach. This 3S-CMD approach explicitly takes into account not only the long range Coulomb reorientation of the deformed collision partner but also the internal vibrational excitations of one or both the nuclei at distances close to the barrier. The results of the dynamical simulation for 24Mg+208Pb collision show significant modification of the fusion barrier and calculated fusion cross sections due to internal excitations.

  16. Scalable and Media Aware Adaptive Video Streaming over Wireless Networks

    Directory of Open Access Journals (Sweden)

    Béatrice Pesquet-Popescu

    2008-07-01

    Full Text Available This paper proposes an advanced video streaming system based on scalable video coding in order to optimize resource utilization in wireless networks with retransmission mechanisms at radio protocol level. The key component of this system is a packet scheduling algorithm which operates on the different substreams of a main scalable video stream and which is implemented in a so-called media aware network element. The concerned type of transport channel is a dedicated channel subject to parameters (bitrate, loss rate variations on the long run. Moreover, we propose a combined scalability approach in which common temporal and SNR scalability features can be used jointly with a partitioning of the image into regions of interest. Simulation results show that our approach provides substantial quality gain compared to classical packet transmission methods and they demonstrate how ROI coding combined with SNR scalability allows to improve again the visual quality.

  17. Scalable Stream Processing with Quality of Service for Smart City Crowdsensing Applications

    Directory of Open Access Journals (Sweden)

    Paolo Bellavista

    2013-12-01

    Full Text Available Crowdsensing is emerging as a powerful paradigm capable of leveraging the collective, though imprecise, monitoring capabilities of common people carrying smartphones or other personal devices, which can effectively become real-time mobile sensors, collecting information about the physical places they live in. This unprecedented amount of information, considered collectively, offers new valuable opportunities to understand more thoroughly the environment in which we live and, more importantly, gives the chance to use this deeper knowledge to act and improve, in a virtuous loop, the environment itself. However, managing this process is a hard technical challenge, spanning several socio-technical issues: here, we focus on the related quality, reliability, and scalability trade-offs by proposing an architecture for crowdsensing platforms that dynamically self-configure and self-adapt depending on application-specific quality requirements. In the context of this general architecture, the paper will specifically focus on the Quasit distributed stream processing middleware, and show how Quasit can be used to process and analyze crowdsensing-generated data flows with differentiated quality requirements in a highly scalable and reliable way.

  18. Evaluation of uranium dioxide thermal conductivity using molecular dynamics simulations

    International Nuclear Information System (INIS)

    Kim, Woongkee; Kaviany, Massoud; Shim, J. H.

    2014-01-01

    It can be extended to larger space, time scale and even real reactor situation with fission product as multi-scale formalism. Uranium dioxide is a fluorite structure with Fm3m space group. Since it is insulator, dominant heat carrier is phonon, rather than electrons. So, using equilibrium molecular dynamics (MD) simulation, we present the appropriate calculation parameters in MD simulation by calculating thermal conductivity and application of it to the thermal conductivity of polycrystal. In this work, we investigate thermal conductivity of uranium dioxide and optimize the parameters related to its process. In this process, called Green Kubo formula, there are two parameters i.e correlation length and sampling interval, which effect on ensemble integration in order to obtain thermal conductivity. Through several comparisons, long correlation length and short sampling interval give better results. Using this strategy, thermal conductivity of poly crystal is obtained and comparison with that of pure crystal is made. Thermal conductivity of poly crystal show lower value that that of pure crystal. In further study, we broaden the study to transport coefficient of radiation damaged structures using molecular dynamics. Although molecular dynamics is tools for treating microscopic scale, most macroscopic issues related to nuclear materials such as voids in fuel materials and weakened mechanical properties by radiation are based on microscopic basis. Thus, research on microscopic scale would be expanded in this field and many hidden mechanism in atomic scales will be revealed via both atomic scale simulations and experiments

  19. Charge Carrier Dynamics at Silver Nanocluster-Molecular Acceptor Interfaces

    KAUST Repository

    Almansaf, Abdulkhaleq

    2017-07-01

    A fundamental understanding of interfacial charge transfer at donor-acceptor interfaces is very crucial as it is considered among the most important dynamical processes for optimizing performance in many light harvesting systems, including photovoltaics and photo-catalysis. In general, the photo-generated singlet excitons in photoactive materials exhibit very short lifetimes because of their dipole-allowed spin radiative decay and short diffusion lengths. In contrast, the radiative decay of triplet excitons is dipole forbidden; therefore, their lifetimes are considerably longer. The discussion in this thesis primarily focuses on the relevant parameters that are involved in charge separation (CS), charge transfer (CT), intersystem crossing (ISC) rate, triplet state lifetime, and carrier recombination (CR) at silver nanocluster (NCs) molecular-acceptors interfaces. A combination of steady-state and femto- and nanosecond broadband transient absorption spectroscopies were used to investigate the charge carrier dynamics in various donor-acceptor systems. Additionally, this thesis was prolonged to investigate some important factors that influence the charge carrier dynamics in Ag29 silver NCs donor-acceptor systems, such as the metal doping and chemical structure of the nanocluster and molecular acceptors. Interestingly, clear correlations between the steady-state measurements and timeresolved spectroscopy results are found. In the first study, we have investigated the interfacial charge transfer dynamics in positively charged meso units of 5, 10, 15, 20-tetra (1- methyl-4-pyridino)-porphyrin tetra (p-toluene sulfonate) (TMPyP) and neutral charged 5, 10, 15, 20-tetra (4-pyridyl)-porphyrin (TPyP), with negatively charged undoped and gold (Au)- doped silver Ag29 NCs. Moreover, this study showed the impact of Au doping on the charge carrier dynamics of the system. In the second study, we have investigated the interfacial charge transfer dynamics in [Pt2 Ag23 Cl7 (PPh3

  20. Triboelectric Charging at the Nanostructured Solid/Liquid Interface for Area-Scalable Wave Energy Conversion and Its Use in Corrosion Protection.

    Science.gov (United States)

    Zhao, Xue Jiao; Zhu, Guang; Fan, You Jun; Li, Hua Yang; Wang, Zhong Lin

    2015-07-28

    We report a flexible and area-scalable energy-harvesting technique for converting kinetic wave energy. Triboelectrification as a result of direct interaction between a dynamic wave and a large-area nanostructured solid surface produces an induced current among an array of electrodes. An integration method ensures that the induced current between any pair of electrodes can be constructively added up, which enables significant enhancement in output power and realizes area-scalable integration of electrode arrays. Internal and external factors that affect the electric output are comprehensively discussed. The produced electricity not only drives small electronics but also achieves effective impressed current cathodic protection. This type of thin-film-based device is a potentially practical solution of on-site sustained power supply at either coastal or off-shore sites wherever a dynamic wave is available. Potential applications include corrosion protection, pollution degradation, water desalination, and wireless sensing for marine surveillance.

  1. Design issues for numerical libraries on scalable multicore architectures

    International Nuclear Information System (INIS)

    Heroux, M A

    2008-01-01

    Future generations of scalable computers will rely on multicore nodes for a significant portion of overall system performance. At present, most applications and libraries cannot exploit multiple cores beyond running addition MPI processes per node. In this paper we discuss important multicore architecture issues, programming models, algorithms requirements and software design related to effective use of scalable multicore computers. In particular, we focus on important issues for library research and development, making recommendations for how to effectively develop libraries for future scalable computer systems

  2. Petascale molecular dynamics simulation using the fast multipole method on K computer

    KAUST Repository

    Ohno, Yousuke; Yokota, Rio; Koyama, Hiroshi; Morimoto, Gentaro; Hasegawa, Aki; Masumoto, Gen; Okimoto, Noriaki; Hirano, Yoshinori; Ibeid, Huda; Narumi, Tetsu; Taiji, Makoto

    2014-01-01

    In this paper, we report all-atom simulations of molecular crowding - a result from the full node simulation on the "K computer", which is a 10-PFLOPS supercomputer in Japan. The capability of this machine enables us to perform simulation of crowded cellular environments, which are more realistic compared to conventional MD simulations where proteins are simulated in isolation. Living cells are "crowded" because macromolecules comprise ∼30% of their molecular weight. Recently, the effects of crowded cellular environments on protein stability have been revealed through in-cell NMR spectroscopy. To measure the performance of the "K computer", we performed all-atom classical molecular dynamics simulations of two systems: target proteins in a solvent, and target proteins in an environment of molecular crowders that mimic the conditions of a living cell. Using the full system, we achieved 4.4 PFLOPS during a 520 million-atom simulation with cutoff of 28 Å. Furthermore, we discuss the performance and scaling of fast multipole methods for molecular dynamics simulations on the "K computer", as well as comparisons with Ewald summation methods. © 2014 Elsevier B.V. All rights reserved.

  3. Petascale molecular dynamics simulation using the fast multipole method on K computer

    KAUST Repository

    Ohno, Yousuke

    2014-10-01

    In this paper, we report all-atom simulations of molecular crowding - a result from the full node simulation on the "K computer", which is a 10-PFLOPS supercomputer in Japan. The capability of this machine enables us to perform simulation of crowded cellular environments, which are more realistic compared to conventional MD simulations where proteins are simulated in isolation. Living cells are "crowded" because macromolecules comprise ∼30% of their molecular weight. Recently, the effects of crowded cellular environments on protein stability have been revealed through in-cell NMR spectroscopy. To measure the performance of the "K computer", we performed all-atom classical molecular dynamics simulations of two systems: target proteins in a solvent, and target proteins in an environment of molecular crowders that mimic the conditions of a living cell. Using the full system, we achieved 4.4 PFLOPS during a 520 million-atom simulation with cutoff of 28 Å. Furthermore, we discuss the performance and scaling of fast multipole methods for molecular dynamics simulations on the "K computer", as well as comparisons with Ewald summation methods. © 2014 Elsevier B.V. All rights reserved.

  4. In situ structure and dynamics of DNA origami determined through molecular dynamics simulations.

    Science.gov (United States)

    Yoo, Jejoong; Aksimentiev, Aleksei

    2013-12-10

    The DNA origami method permits folding of long single-stranded DNA into complex 3D structures with subnanometer precision. Transmission electron microscopy, atomic force microscopy, and recently cryo-EM tomography have been used to characterize the properties of such DNA origami objects, however their microscopic structures and dynamics have remained unknown. Here, we report the results of all-atom molecular dynamics simulations that characterized the structural and mechanical properties of DNA origami objects in unprecedented microscopic detail. When simulated in an aqueous environment, the structures of DNA origami objects depart from their idealized targets as a result of steric, electrostatic, and solvent-mediated forces. Whereas the global structural features of such relaxed conformations conform to the target designs, local deformations are abundant and vary in magnitude along the structures. In contrast to their free-solution conformation, the Holliday junctions in the DNA origami structures adopt a left-handed antiparallel conformation. We find the DNA origami structures undergo considerable temporal fluctuations on both local and global scales. Analysis of such structural fluctuations reveals the local mechanical properties of the DNA origami objects. The lattice type of the structures considerably affects global mechanical properties such as bending rigidity. Our study demonstrates the potential of all-atom molecular dynamics simulations to play a considerable role in future development of the DNA origami field by providing accurate, quantitative assessment of local and global structural and mechanical properties of DNA origami objects.

  5. Molecular dynamics of interfacial water and cations associated with clay minerals

    International Nuclear Information System (INIS)

    Cygan, Randall T.; Greathouse, Jeffery A.; Teich-McGoldrick, Stephanie L.; Nenoff, Tina M.; Daemen, Luke L.

    2012-01-01

    Document available in extended abstract form only. Clay mineral interfaces, including interlayer and external surfaces, play an essential role in many geochemical processes. Adsorption, dissolution, precipitation, nucleation, and growth mechanisms, in particular, are controlled by the interplay of structure, thermodynamics, kinetics, and transport at clay mineral-water interfaces. Molecular details of these geochemical processes are especially important in evaluating the fate of radionuclide waste in the environment. Such details are typically beyond the sensitivity of experimental and analytical methods and therefore require accurate models and simulations. Also, the basal surfaces and interlayers of clay minerals offer structurally constrained interfacial environments to better evaluate the local molecular chemistry. We have developed and used classical and quantum methods to examine the complex behavior of clay mineral-water interfaces and dynamics of interlayer species. Bulk structures, swelling behavior, diffusion, and adsorption processes are evaluated and compared to experimental and spectroscopic findings. In particular, inelastic neutron scattering methods provide a successful probe of vibrational behavior of interlayer species to help guide the simulations. Librations involving rock, wag, and twist motions of water molecules are particularly sensitive to the interlayer environment of smectite minerals such as montmorillonite and beidellite. Trends in librational modes for interlayer water as a function of clay structure and cation hydration energy are readily explained using structural and vibrational analysis derived from molecular simulation. Molecular dynamics simulations of virtual phases, including hydrated pyrophyllite, help to explain the behavior of interlayer water that is not associated with cation species. Additionally, we use large-scale molecular dynamics simulations of other layered minerals, such as muscovite, to evaluate adsorption

  6. Molecular dynamics simulation of polyacrylamides in potassium montmorillonite clay hydrates

    Energy Technology Data Exchange (ETDEWEB)

    Zhang Junfang [CSIRO Petroleum Resources, Ian Wark Laboratory, Bayview Avenue, Clayton, Victoria 3168 (Australia); Rivero, Mayela [CSIRO Petroleum, PO Box 1130, Bentley, Western Australia, 6102 (Australia); Choi, S K [CSIRO Petroleum Resources, Ian Wark Laboratory, Bayview Avenue, Clayton, Victoria 3168 (Australia)

    2007-02-14

    We present molecular dynamics simulation results for polyacrylamide in potassium montmorillonite clay-aqueous systems. Interlayer molecular structure and dynamics properties are investigated. The number density profile, radial distribution function, root-mean-square deviation (RMSD), mean-square displacement (MSD) and diffusion coefficient are reported. The calculations are conducted in constant NVT ensembles, at T = 300 K and with layer spacing of 40 A. Our simulation results showed that polyacrylamides had little impact on the structure of interlayer water. Density profiles and radial distribution function indicated that hydration shells were formed. In the presence of polyacrylamides more potassium counterions move close to the clay surface while water molecules move away, indicating that potassium counterions are hydrated to a lesser extent than the system in which no polyacrylamides were added. The diffusion coefficients for potassium and water decreased when polyacrylamides were added.

  7. Molecular dynamics study on the relaxation properties of bilayered ...

    Indian Academy of Sciences (India)

    2017-08-31

    Aug 31, 2017 ... Abstract. The influence of defects on the relaxation properties of bilayered graphene (BLG) has been studied by molecular dynamics simulation in nanometre sizes. Type and position of defects were taken into account in the calculated model. The results show that great changes begin to occur in the ...

  8. Molecular dynamics studies of crystalline nucleation in one-component Yukawa plasmas

    International Nuclear Information System (INIS)

    Ravelo, R.; Hammerberg, J.E.; Holian, B.L.

    1992-01-01

    We report on molecular dynamics studies of one-component Yukawa plasmas undergoing rapid quenches from a fluid state with a Coulomb parameter Γ = 40 to solid states in the range 350 < Γ < 800. The detailed dynamical structure of ordering appears more complicated than results from classical theories of nucleation, with planar formation being observed before fully 3-dimensional ordering appears

  9. Molecular dynamics simulation of a DNA containing a single strand break

    Energy Technology Data Exchange (ETDEWEB)

    Yamaguchi, H.; Siebers, G.; Furukawa, A.; Otagiri, N.; Osman, R

    2002-07-01

    Molecular dynamics simulations were performed for a dodecamer DNA containing a single strand break (SSB), which has been represented by a 3'-OH deoxyribose and 5'-OH phosphate in the middle of the strand. Molecular force field parameters of the 5'-OH phosphate region were determined from an ab initio calculation at the HF/6-31G level using the program package GAMESS. The DNA was placed in a periodic boundary box with water molecules and Na+ counter-ions to produce a neutralised system. After minimisation, the system was heated to 300 K, equilibrated and a production run at constant NTP was executed for 1 ns using AMBER 4.1. Snapshots of the SSB-containing DNA and a detailed analysis of the equilibriated average structure revealed surprisingly small conformational changes compared to normal DNA. However, dynamic properties calculated using the essential dynamics method showed some features that may be important for the recognition of this damage by repair enzymes. (author)

  10. Dynamic superhydrophobic behavior in scalable random textured polymeric surfaces

    Science.gov (United States)

    Moreira, David; Park, Sung-hoon; Lee, Sangeui; Verma, Neil; Bandaru, Prabhakar R.

    2016-03-01

    Superhydrophobic (SH) surfaces, created from hydrophobic materials with micro- or nano- roughness, trap air pockets in the interstices of the roughness, leading, in fluid flow conditions, to shear-free regions with finite interfacial fluid velocity and reduced resistance to flow. Significant attention has been given to SH conditions on ordered, periodic surfaces. However, in practical terms, random surfaces are more applicable due to their relative ease of fabrication. We investigate SH behavior on a novel durable polymeric rough surface created through a scalable roll-coating process with varying micro-scale roughness through velocity and pressure drop measurements. We introduce a new method to construct the velocity profile over SH surfaces with significant roughness in microchannels. Slip length was measured as a function of differing roughness and interstitial air conditions, with roughness and air fraction parameters obtained through direct visualization. The slip length was matched to scaling laws with good agreement. Roughness at high air fractions led to a reduced pressure drop and higher velocities, demonstrating the effectiveness of the considered surface in terms of reduced resistance to flow. We conclude that the observed air fraction under flow conditions is the primary factor determining the response in fluid flow. Such behavior correlated well with the hydrophobic or superhydrophobic response, indicating significant potential for practical use in enhancing fluid flow efficiency.

  11. Accelerated sampling by infinite swapping of path integral molecular dynamics with surface hopping

    Science.gov (United States)

    Lu, Jianfeng; Zhou, Zhennan

    2018-02-01

    To accelerate the thermal equilibrium sampling of multi-level quantum systems, the infinite swapping limit of a recently proposed multi-level ring polymer representation is investigated. In the infinite swapping limit, the ring polymer evolves according to an averaged Hamiltonian with respect to all possible surface index configurations of the ring polymer and thus connects the surface hopping approach to the mean-field path-integral molecular dynamics. A multiscale integrator for the infinite swapping limit is also proposed to enable efficient sampling based on the limiting dynamics. Numerical results demonstrate the huge improvement of sampling efficiency of the infinite swapping compared with the direct simulation of path-integral molecular dynamics with surface hopping.

  12. Molecular structures and intramolecular dynamics of pentahalides

    Science.gov (United States)

    Ischenko, A. A.

    2017-03-01

    This paper reviews advances of modern gas electron diffraction (GED) method combined with high-resolution spectroscopy and quantum chemical calculations in studies of the impact of intramolecular dynamics in free molecules of pentahalides. Some recently developed approaches to the electron diffraction data interpretation, based on direct incorporation of the adiabatic potential energy surface parameters to the diffraction intensity are described. In this way, complementary data of different experimental and computational methods can be directly combined for solving problems of the molecular structure and its dynamics. The possibility to evaluate some important parameters of the adiabatic potential energy surface - barriers to pseudorotation and saddle point of intermediate configuration from diffraction intensities in solving the inverse GED problem is demonstrated on several examples. With increasing accuracy of the electron diffraction intensities and the development of the theoretical background of electron scattering and data interpretation, it has become possible to investigate complex nuclear dynamics in fluxional systems by the GED method. Results of other research groups are also included in the discussion.

  13. Multiscale simulations of patchy particle systems combining Molecular Dynamics, Path Sampling and Green's Function Reaction Dynamics

    Science.gov (United States)

    Bolhuis, Peter

    Important reaction-diffusion processes, such as biochemical networks in living cells, or self-assembling soft matter, span many orders in length and time scales. In these systems, the reactants' spatial dynamics at mesoscopic length and time scales of microns and seconds is coupled to the reactions between the molecules at microscopic length and time scales of nanometers and milliseconds. This wide range of length and time scales makes these systems notoriously difficult to simulate. While mean-field rate equations cannot describe such processes, the mesoscopic Green's Function Reaction Dynamics (GFRD) method enables efficient simulation at the particle level provided the microscopic dynamics can be integrated out. Yet, many processes exhibit non-trivial microscopic dynamics that can qualitatively change the macroscopic behavior, calling for an atomistic, microscopic description. The recently developed multiscale Molecular Dynamics Green's Function Reaction Dynamics (MD-GFRD) approach combines GFRD for simulating the system at the mesocopic scale where particles are far apart, with microscopic Molecular (or Brownian) Dynamics, for simulating the system at the microscopic scale where reactants are in close proximity. The association and dissociation of particles are treated with rare event path sampling techniques. I will illustrate the efficiency of this method for patchy particle systems. Replacing the microscopic regime with a Markov State Model avoids the microscopic regime completely. The MSM is then pre-computed using advanced path-sampling techniques such as multistate transition interface sampling. I illustrate this approach on patchy particle systems that show multiple modes of binding. MD-GFRD is generic, and can be used to efficiently simulate reaction-diffusion systems at the particle level, including the orientational dynamics, opening up the possibility for large-scale simulations of e.g. protein signaling networks.

  14. Probing molecular interactions in bone biomaterials: Through molecular dynamics and Fourier transform infrared spectroscopy

    International Nuclear Information System (INIS)

    Bhowmik, Rahul; Katti, Kalpana S.; Verma, Devendra; Katti, Dinesh R.

    2007-01-01

    Polymer-hydroxyapatite (HAP) composites are widely investigated for their potential use as bone replacement materials. The molecular interactions at mineral polymer interface are known to have significant role of mechanical response of the composite system. Modeling interactions between such dissimilar molecules using molecular dynamics (MD) is an area of current interest. Molecular dynamics studies require potential function or force field parameters. Some force fields are described in literature that represents the structure of hydroxyapatite reasonably well. Yet, the applicability of these force fields for studying the interaction between dissimilar materials (such as mineral and polymer) is limited, as there is no accurate representation of polymer in these force fields. We have obtained the parameters of consistent valence force field (CVFF) for monoclinic hydroxyapatite. Validation of parameters was done by comparing the computationally obtained unit cell parameters, vibrational spectra and atomic distances with XRD and FTIR experiments. Using the obtained parameters of HAP, and available parameters of polymer (polyacrylic acid), interaction study was performed with MD simulations. The MD simulations showed that several hydrogen bonds may form between HAP and polyacrylic acid depending upon the exposed surface of HAP. Also there are some favourable planes of HAP where polyacrylic acid is most likely to attach. We have also simulated the mineralization of HAP using a 'synthetic biomineralization'. These modeling studies are supported by photoacoustic spectroscopy experiments on both porous and non porous composite samples for potential joint replacement and bone tissue engineering applications

  15. A new shared-memory programming paradigm for molecular dynamics simulations on the Intel Paragon

    International Nuclear Information System (INIS)

    D'Azevedo, E.F.; Romine, C.H.

    1994-12-01

    This report describes the use of shared memory emulation with DOLIB (Distributed Object Library) to simplify parallel programming on the Intel Paragon. A molecular dynamics application is used as an example to illustrate the use of the DOLIB shared memory library. SOTON-PAR, a parallel molecular dynamics code with explicit message-passing using a Lennard-Jones 6-12 potential, is rewritten using DOLIB primitives. The resulting code has no explicit message primitives and resembles a serial code. The new code can perform dynamic load balancing and achieves better performance than the original parallel code with explicit message-passing

  16. A Cytomorphic Chip for Quantitative Modeling of Fundamental Bio-Molecular Circuits.

    Science.gov (United States)

    2015-08-01

    We describe a 0.35 μm BiCMOS silicon chip that quantitatively models fundamental molecular circuits via efficient log-domain cytomorphic transistor equivalents. These circuits include those for biochemical binding with automatic representation of non-modular and loading behavior, e.g., in cascade and fan-out topologies; for representing variable Hill-coefficient operation and cooperative binding; for representing inducer, transcription-factor, and DNA binding; for probabilistic gene transcription with analogic representations of log-linear and saturating operation; for gain, degradation, and dynamics of mRNA and protein variables in transcription and translation; and, for faithfully representing biological noise via tunable stochastic transistor circuits. The use of on-chip DACs and ADCs enables multiple chips to interact via incoming and outgoing molecular digital data packets and thus create scalable biochemical reaction networks. The use of off-chip digital processors and on-chip digital memory enables programmable connectivity and parameter storage. We show that published static and dynamic MATLAB models of synthetic biological circuits including repressilators, feed-forward loops, and feedback oscillators are in excellent quantitative agreement with those from transistor circuits on the chip. Computationally intensive stochastic Gillespie simulations of molecular production are also rapidly reproduced by the chip and can be reliably tuned over the range of signal-to-noise ratios observed in biological cells.

  17. Applications of the semiclassical spectral method to nuclear, atomic, molecular, and polymeric dynamics

    International Nuclear Information System (INIS)

    Koszykowski, M.L.; Pfeffer, G.A.; Noid, D.W.

    1987-01-01

    Nonlinear dynamics plays a dominant role in a variety of important problems in chemical physics. Examples are unimolecular reactions, infrared multiphoton decomposition of molecules, the pumping process of the gamma ray laser, dissociation of vibrationally excited state-selected van der Waals's complexes, and many other chemical and atomic processes. The present article discusses recent theoretical studies on the quasi-periodic and chaotic dynamic aspects of vibrational-rotational states of atomic, nuclear, and molecular systems using the semiclassical spectral method (SSM). The authors note that the coordinates, momenta, and so on, are found using classical mechanics in the studies included in this review. They outline the semiclassical spectral method and a wide variety of applications. Although this technique was first developed ten years ago, it has proved to be tremendously successful as a tool used in dynamics problems. Applications include problems in nonlinear dynamics, molecular and atomic spectra, surface science, astronomy and stellar dynamics, nuclear physics, and polymer physics

  18. Elastic properties of surfactant monolayers at liquid-liquid interfaces: A molecular dynamics study

    DEFF Research Database (Denmark)

    Laradji, Mohamed; Mouritsen, Ole G.

    2000-01-01

    Using a simple molecular model based on the Lennard-Jones potential, we systematically study the elastic properties of liquid-liquid interfaces containing surfactant molecules by means of extensive and large-scale molecular dynamics simulations. The main elastic constants of the interface, corres...

  19. Vision-Augmented Molecular Dynamics Simulation of Nanoindentation

    Directory of Open Access Journals (Sweden)

    Rajab Al-Sayegh

    2015-01-01

    Full Text Available We present a user-friendly vision-augmented technique to carry out atomic simulation using hand gestures. The system is novel in its concept as it enables the user to directly manipulate the atomic structures on the screen, in 3D space using hand gestures, allowing the exploration and visualisation of molecular interactions at different relative conformations. The hand gestures are used to pick and place atoms on the screen allowing thereby the ease of carrying out molecular dynamics simulation in a more efficient way. The end result is that users with limited expertise in developing molecular structures can now do so easily and intuitively by the use of body gestures to interact with the simulator to study the system in question. The proposed system was tested by simulating the crystal anisotropy of crystalline silicon during nanoindentation. A long-range (Screened bond order Tersoff potential energy function was used during the simulation which revealed the value of hardness and elastic modulus being similar to what has been found previously from the experiments. We anticipate that our proposed system will open up new horizons to the current methods on how an MD simulation is designed and executed.

  20. Coupled electron-phonon transport from molecular dynamics with quantum baths

    DEFF Research Database (Denmark)

    Lu, Jing Tao; Wang, J. S.

    2009-01-01

    Based on generalized quantum Langevin equations for the tight-binding wavefunction amplitudes and lattice displacements, electron and phonon quantum transport are obtained exactly using molecular dynamics (MD) in the ballistic regime. The electron-phonon interactions can be handled with a quasi...

  1. Scalable manufacturing of biomimetic moldable hydrogels for industrial applications

    Science.gov (United States)

    Yu, Anthony C.; Chen, Haoxuan; Chan, Doreen; Agmon, Gillie; Stapleton, Lyndsay M.; Sevit, Alex M.; Tibbitt, Mark W.; Acosta, Jesse D.; Zhang, Tony; Franzia, Paul W.; Langer, Robert; Appel, Eric A.

    2016-12-01

    Hydrogels are a class of soft material that is exploited in many, often completely disparate, industrial applications, on account of their unique and tunable properties. Advances in soft material design are yielding next-generation moldable hydrogels that address engineering criteria in several industrial settings such as complex viscosity modifiers, hydraulic or injection fluids, and sprayable carriers. Industrial implementation of these viscoelastic materials requires extreme volumes of material, upwards of several hundred million gallons per year. Here, we demonstrate a paradigm for the scalable fabrication of self-assembled moldable hydrogels using rationally engineered, biomimetic polymer-nanoparticle interactions. Cellulose derivatives are linked together by selective adsorption to silica nanoparticles via dynamic and multivalent interactions. We show that the self-assembly process for gel formation is easily scaled in a linear fashion from 0.5 mL to over 15 L without alteration of the mechanical properties of the resultant materials. The facile and scalable preparation of these materials leveraging self-assembly of inexpensive, renewable, and environmentally benign starting materials, coupled with the tunability of their properties, make them amenable to a range of industrial applications. In particular, we demonstrate their utility as injectable materials for pipeline maintenance and product recovery in industrial food manufacturing as well as their use as sprayable carriers for robust application of fire retardants in preventing wildland fires.

  2. A resource letter CSSMD-1: computer simulation studies by the method of molecular dynamics

    International Nuclear Information System (INIS)

    Goel, S.P.; Hockney, R.W.

    1974-01-01

    A comprehensive bibliography on computer simulation studies by the method of Molecular Dynamics is presented. The bibliography includes references to relevant literature published up to mid 1973, starting from the first paper of Alder and Wainwright, published in 1957. The procedure of the method of Molecular Dynamics, the main fields of study in which it has been used, its limitations and how these have been overcome in some cases are also discussed [pt

  3. Large-scale molecular dynamics simulations of self-assembling systems.

    Science.gov (United States)

    Klein, Michael L; Shinoda, Wataru

    2008-08-08

    Relentless increases in the size and performance of multiprocessor computers, coupled with new algorithms and methods, have led to novel applications of simulations across chemistry. This Perspective focuses on the use of classical molecular dynamics and so-called coarse-grain models to explore phenomena involving self-assembly in complex fluids and biological systems.

  4. Development of a quantum chemical molecular dynamics tribochemical simulator and its application to tribochemical reaction dynamics of lubricant additives

    International Nuclear Information System (INIS)

    Onodera, T; Tsuboi, H; Hatakeyama, N; Endou, A; Miyamoto, A; Miura, R; Takaba, H; Suzuki, A; Kubo, M

    2010-01-01

    Tribology at the atomistic and molecular levels has been theoretically studied by a classical molecular dynamics (MD) method. However, this method inherently cannot simulate the tribochemical reaction dynamics because it does not consider the electrons in nature. Although the first-principles based MD method has recently been used for understanding the chemical reaction dynamics of several molecules in the tribology field, the method cannot simulate the tribochemical reaction dynamics of a large complex system including solid surfaces and interfaces due to its huge computation costs. On the other hand, we have developed a quantum chemical MD tribochemical simulator on the basis of a hybrid tight-binding quantum chemical/classical MD method. In the simulator, the central part of the chemical reaction dynamics is calculated by the tight-binding quantum chemical MD method, and the remaining part is calculated by the classical MD method. Therefore, the developed tribochemical simulator realizes the study on tribochemical reaction dynamics of a large complex system, which cannot be treated by using the conventional classical MD or the first-principles MD methods. In this paper, we review our developed quantum chemical MD tribochemical simulator and its application to the tribochemical reaction dynamics of a few lubricant additives

  5. Classical molecular dynamics simulation of weakly-bound projectile heavy-ion reactions

    Directory of Open Access Journals (Sweden)

    Morker Mitul R.

    2015-01-01

    Full Text Available A 3-body classical molecular dynamics approach for heavy-ion reactions involving weakly bound projectiles is developed. In this approach a weakly bound projectile is constructed as a two-body cluster of the constituent tightly bound nuclei in a configuration corresponding to the observed breakup energy. This 3-body system with their individual nucleon configuration in their ground state is dynamically evolved for given initial conditions using the three-stage classical molecular dynamics approach (3S-CMD. Various levels of rigidbody constraints on the projectile constituents and the target are considered at appropriate stages. This 3-dimensional approach explicitly takes into account not only the long range Coulomb reorientation of the deformed collision partner but internal excitations and breakup probabilities at distances close to the barrier also. Dynamical simulations of 6Li+209Bi show all the possible reaction mechanism like complete fusion, incomplete fusion, scattering and breakup scattering. Complete fusion cross sections of 6Li+209Bi and 7Li+209Bi reactions are calculated in this approach with systematic relaxations of the rigid-body constraints on one or more constituent nuclei.

  6. Dynamic Defrosting on Scalable Superhydrophobic Surfaces

    International Nuclear Information System (INIS)

    Murphy, Kevin R.; McClintic, William T.; Lester, Kevin C.; Collier, C. Patrick; Boreyko, Jonathan B.

    2017-01-01

    Recent studies have shown that frost can grow in a suspended Cassie state on nanostructured superhydrophobic surfaces. During defrosting, the melting sheet of Cassie frost spontaneously dewets into quasi-spherical slush droplets that are highly mobile. Promoting Cassie frost would therefore seem advantageous from a defrosting standpoint; however, nobody has systematically compared the efficiency of defrosting Cassie ice versus defrosting conventional surfaces. Here, we characterize the defrosting of an aluminum plate, one-half of which exhibits a superhydrophobic nanostructure while the other half is smooth and hydrophobic. For thick frost sheets (>1 mm), the superhydrophobic surface was able to dynamically shed the meltwater, even at very low tilt angles. In contrast, the hydrophobic surface was unable to shed any appreciable meltwater even at a 90° tilt angle. For thin frost layers (≲1 mm), not even the superhydrophobic surface could mobilize the meltwater. We attribute this to the large apparent contact angle of the meltwater, which for small amounts of frost serves to minimize coalescence events and prevent droplets from approaching the capillary length. Finally, we demonstrate a new mode of dynamic defrosting using an upside-down surface orientation, where the melting frost was able to uniformly detach from the superhydrophobic side and subsequently pull the frost from the hydrophobic side in a chain reaction. Treating surfaces to enable Cassie frost is therefore very desirable for enabling rapid and low-energy thermal defrosting, but only for frost sheets that are sufficiently thick.

  7. Molecular dynamics of bacteriorhodopsin.

    Science.gov (United States)

    Lupo, J A; Pachter, R

    1997-02-01

    A model of bacteriorhodopsin (bR), with a retinal chromophore attached, has been derived for a molecular dynamics simulation. A method for determining atomic coordinates of several ill-defined strands was developed using a structure prediction algorithm based on a sequential Kalman filter technique. The completed structure was minimized using the GROMOS force field. The structure was then heated to 293 K and run for 500 ps at constant temperature. A comparison with the energy-minimized structure showed a slow increase in the all-atom RMS deviation over the first 200 ps, leveling off to approximately 2.4 A relative to the starting structure. The final structure yielded a backbone-atom RMS deviation from the crystallographic structure of 2.8 A. The residue neighbors of the chromophore atoms were followed as a function of time. The set of persistent near-residue neighbors supports the theory that differences in pKa values control access to the Schiff base proton, rather than formation of a counterion complex.

  8. Magnetic effects on the solvent properties investigated by molecular dynamics simulation

    Energy Technology Data Exchange (ETDEWEB)

    Moosavi, Fatemeh, E-mail: moosavibaigi@um.ac.ir; Gholizadeh, Mostafa

    2014-03-15

    This paper investigates how an external constant magnetic field in the Z-direction affects the performance of a solvent. The molecular dynamics simulation comprised common inorganic and organic solvents including water, acetone, acetonitrile, toluene, and n-hexane at the ambient temperature and pressure. A static magnetic field applied in the simulation process is able to reduce the solvent mobility in the solution in order to enhance the solvent–solute reaction. Simulation results show that the diffusivity decreases because of increasing the effective interactions. Besides, magnetic field reduces the volume of the solvent and increases the strength of the hydrogen bonds by maximizing attractive electrostatic and vdW interactions caused by changes in the radial distribution function of the solvents. Hydrogen-bonding characteristics of solvents investigated by molecular dynamics simulations were evidence for the hydrogen bonding strength of O···H that is a more efficient intermolecular hydrogen-bonding in comparison with N···H. - Highlights: • Molecular dynamics simulation technique investigates the effect of magnetic field on transport dynamics inside the solvent bulk. • External constant magnetic field influences on intermolecular interactions, thermophysics, and transport properties of the solvents. • Applying magnetic field strengthened hydrogen bond maximizes attractive electrostatic interactions, charge distribution becomes stronger, and the molecule mobility is demoted. • The low diffusivity of the solvents in the solutions increases the performance of the interactions and promotes the interactions. • On introducing a magnetic field of flux density parallel to the Z-direction, solvent acts as an obstacle to diffusion of solutes.

  9. Building scalable apps with Redis and Node.js

    CERN Document Server

    Johanan, Joshua

    2014-01-01

    If the phrase scalability sounds alien to you, then this is an ideal book for you. You will not need much Node.js experience as each framework is demonstrated in a way that requires no previous knowledge of the framework. You will be building scalable Node.js applications in no time! Knowledge of JavaScript is required.

  10. Scalable shared-memory multiprocessing

    CERN Document Server

    Lenoski, Daniel E

    1995-01-01

    Dr. Lenoski and Dr. Weber have experience with leading-edge research and practical issues involved in implementing large-scale parallel systems. They were key contributors to the architecture and design of the DASH multiprocessor. Currently, they are involved with commercializing scalable shared-memory technology.

  11. Molecular dynamics of polarizable point dipole models for molten NaI. Comparison with first principles simulations

    Directory of Open Access Journals (Sweden)

    Trullàs J.

    2011-05-01

    Full Text Available Molecular dynamics simulations of molten NaI at 995 K have been carried out using polarizable ion models based on rigid ion pair potentials to which the anion induced dipole polarization is added. The polarization is added in such a way that point dipoles are induced on the anions by both local electric field and deformation short-range damping interactions that oppose the electrically induced dipole moments. The structure and self-diffusion results are compared with those obtained by Galamba and Costa Cabral using first principles Hellmann-Feynman molecular dynamics simulations and using classical molecular dynamics of a shell model which allows only the iodide polarization

  12. Thermal conductivity of water: Molecular dynamics and generalized hydrodynamics results

    Science.gov (United States)

    Bertolini, Davide; Tani, Alessandro

    1997-10-01

    Equilibrium molecular dynamics simulations have been carried out in the microcanonical ensemble at 300 and 255 K on the extended simple point charge (SPC/E) model of water [Berendsen et al., J. Phys. Chem. 91, 6269 (1987)]. In addition to a number of static and dynamic properties, thermal conductivity λ has been calculated via Green-Kubo integration of the heat current time correlation functions (CF's) in the atomic and molecular formalism, at wave number k=0. The calculated values (0.67+/-0.04 W/mK at 300 K and 0.52+/-0.03 W/mK at 255 K) are in good agreement with the experimental data (0.61 W/mK at 300 K and 0.49 W/mK at 255 K). A negative long-time tail of the heat current CF, more apparent at 255 K, is responsible for the anomalous decrease of λ with temperature. An analysis of the dynamical modes contributing to λ has shown that its value is due to two low-frequency exponential-like modes, a faster collisional mode, with positive contribution, and a slower one, which determines the negative long-time tail. A comparison of the molecular and atomic spectra of the heat current CF has suggested that higher-frequency modes should not contribute to λ in this temperature range. Generalized thermal diffusivity DT(k) decreases as a function of k, after an initial minor increase at k=kmin. The k dependence of the generalized thermodynamic properties has been calculated in the atomic and molecular formalisms. The observed differences have been traced back to intramolecular or intermolecular rotational effects and related to the partial structure functions. Finally, from the results we calculated it appears that the SPC/E model gives results in better agreement with experimental data than the transferable intermolecular potential with four points TIP4P water model [Jorgensen et al., J. Chem. Phys. 79, 926 (1983)], with a larger improvement for, e.g., diffusion, viscosities, and dielectric properties and a smaller one for thermal conductivity. The SPC/E model shares

  13. Chemical Dynamics, Molecular Energetics, and Kinetics at the Synchrotron

    International Nuclear Information System (INIS)

    Leone, Stephen R.; Ahmed, Musahid; Wilson, Kevin R.

    2010-01-01

    Scientists at the Chemical Dynamics Beamline of the Advanced Light Source in Berkeley are continuously reinventing synchrotron investigations of physical chemistry and chemical physics with vacuum ultraviolet light. One of the unique aspects of a synchrotron for chemical physics research is the widely tunable vacuum ultraviolet light that permits threshold ionization of large molecules with minimal fragmentation. This provides novel opportunities to assess molecular energetics and reaction mechanisms, even beyond simple gas phase molecules. In this perspective, significant new directions utilizing the capabilities at the Chemical Dynamics Beamline are presented, along with an outlook for future synchrotron and free electron laser science in chemical dynamics. Among the established and emerging fields of investigations are cluster and biological molecule spectroscopy and structure, combustion flame chemistry mechanisms, radical kinetics and product isomer dynamics, aerosol heterogeneous chemistry, planetary and interstellar chemistry, and secondary neutral ion-beam desorption imaging of biological matter and materials chemistry.

  14. Modification of S-Adenosyl-l-Homocysteine as Inhibitor of Nonstructural Protein 5 Methyltransferase Dengue Virus Through Molecular Docking and Molecular Dynamics Simulation.

    Science.gov (United States)

    Tambunan, Usman Sumo Friend; Nasution, Mochammad Arfin Fardiansyah; Azhima, Fauziah; Parikesit, Arli Aditya; Toepak, Erwin Prasetya; Idrus, Syarifuddin; Kerami, Djati

    2017-01-01

    Dengue fever is still a major threat worldwide, approximately threatening two-fifths of the world's population in tropical and subtropical countries. Nonstructural protein 5 (NS5) methyltransferase enzyme plays a vital role in the process of messenger RNA capping of dengue by transferring methyl groups from S -adenosyl-l-methionine to N7 atom of the guanine bases of RNA and the RNA ribose group of 2'OH, resulting in S -adenosyl-l-homocysteine (SAH). The modification of SAH compound was screened using molecular docking and molecular dynamics simulation, along with computational ADME-Tox (absorption, distribution, metabolism, excretion, and toxicity) test. The 2 simulations were performed using Molecular Operating Environment (MOE) 2008.10 software, whereas the ADME-Tox test was performed using various software. The modification of SAH compound was done using several functional groups that possess different polarities and properties, resulting in 3460 ligands to be docked. After conducting docking simulation, we earned 3 best ligands (SAH-M331, SAH-M2696, and SAH-M1356) based on ΔG binding and molecular interactions, which show better results than the standard ligands. Moreover, the results of molecular dynamics simulation show that the best ligands are still able to maintain the active site residue interaction with the binding site until the end of the simulation. After a series of molecular docking and molecular dynamics simulation were performed, we concluded that SAH-M1356 ligand is the most potential SAH-based compound to inhibit NS5 methyltransferase enzyme for treating dengue fever.

  15. Molecular dynamics simulation of nonlinear spectroscopies of intermolecular motions in liquid water.

    Science.gov (United States)

    Yagasaki, Takuma; Saito, Shinji

    2009-09-15

    Water is the most extensively studied of liquids because of both its ubiquity and its anomalous thermodynamic and dynamic properties. The properties of water are dominated by hydrogen bonds and hydrogen bond network rearrangements. Fundamental information on the dynamics of liquid water has been provided by linear infrared (IR), Raman, and neutron-scattering experiments; molecular dynamics simulations have also provided insights. Recently developed higher-order nonlinear spectroscopies open new windows into the study of the hydrogen bond dynamics of liquid water. For example, the vibrational lifetimes of stretches and a bend, intramolecular features of water dynamics, can be accurately measured and are found to be on the femtosecond time scale at room temperature. Higher-order nonlinear spectroscopy is expressed by a multitime correlation function, whereas traditional linear spectroscopy is given by a one-time correlation function. Thus, nonlinear spectroscopy yields more detailed information on the dynamics of condensed media than linear spectroscopy. In this Account, we describe the theoretical background and methods for calculating higher order nonlinear spectroscopy; equilibrium and nonequilibrium molecular dynamics simulations, and a combination of both, are used. We also present the intermolecular dynamics of liquid water revealed by fifth-order two-dimensional (2D) Raman spectroscopy and third-order IR spectroscopy. 2D Raman spectroscopy is sensitive to couplings between modes; the calculated 2D Raman signal of liquid water shows large anharmonicity in the translational motion and strong coupling between the translational and librational motions. Third-order IR spectroscopy makes it possible to examine the time-dependent couplings. The 2D IR spectra and three-pulse photon echo peak shift show the fast frequency modulation of the librational motion. A significant effect of the translational motion on the fast frequency modulation of the librational motion is

  16. Stabilities and Dynamics of Protein Folding Nuclei by Molecular Dynamics Simulation

    Science.gov (United States)

    Song, Yong-Shun; Zhou, Xin; Zheng, Wei-Mou; Wang, Yan-Ting

    2017-07-01

    To understand how the stabilities of key nuclei fragments affect protein folding dynamics, we simulate by molecular dynamics (MD) simulation in aqueous solution four fragments cut out of a protein G, including one α-helix (seqB: KVFKQYAN), two β-turns (seqA: LNGKTLKG and seqC: YDDATKTF), and one β-strand (seqD: DGEWTYDD). The Markov State Model clustering method combined with the coarse-grained conformation letters method are employed to analyze the data sampled from 2-μs equilibrium MD simulation trajectories. We find that seqA and seqB have more stable structures than their native structures which become metastable when cut out of the protein structure. As expected, seqD alone is flexible and does not have a stable structure. Throughout our simulations, the native structure of seqC is stable but cannot be reached if starting from a structure other than the native one, implying a funnel-shape free energy landscape of seqC in aqueous solution. All the above results suggest that different nuclei have different formation dynamics during protein folding, which may have a major contribution to the hierarchy of protein folding dynamics. Supported by the National Basic Research Program of China under Grant No. 2013CB932804, the National Natural Science Foundation of China under Grant No. 11421063, and the CAS Biophysics Interdisciplinary Innovation Team Project

  17. Getting the ion-protein interactions right in molecular dynamics simulations

    Czech Academy of Sciences Publication Activity Database

    Duboué-Dijon, Elise; Mason, Philip E.; Jungwirth, Pavel

    2017-01-01

    Roč. 46, Suppl 1 (2017), S66 ISSN 0175-7571. [IUPAB congress /19./ and EBSA congress /11./. 16.07.2017-20.07.2017, Edinburgh] Institutional support: RVO:61388963 Keywords : ion-protein interaction * molecular dynamics simulations * neutron scattering * insulin Subject RIV: BO - Biophysics

  18. Molecular dynamics simulations of lipid vesicle fusion in atomic detail

    NARCIS (Netherlands)

    Knecht, Volker; Marrink, Siewert-Jan

    The fusion of a membrane-bounded vesicle with a target membrane is a key step in intracellular trafficking, exocytosis, and drug delivery. Molecular dynamics simulations have been used to study the fusion of small unilamellar vesicles composed of a dipalmitoyl-phosphatidylcholine (DPPC)/palmitic

  19. Validating clustering of molecular dynamics simulations using polymer models

    Directory of Open Access Journals (Sweden)

    Phillips Joshua L

    2011-11-01

    Full Text Available Abstract Background Molecular dynamics (MD simulation is a powerful technique for sampling the meta-stable and transitional conformations of proteins and other biomolecules. Computational data clustering has emerged as a useful, automated technique for extracting conformational states from MD simulation data. Despite extensive application, relatively little work has been done to determine if the clustering algorithms are actually extracting useful information. A primary goal of this paper therefore is to provide such an understanding through a detailed analysis of data clustering applied to a series of increasingly complex biopolymer models. Results We develop a novel series of models using basic polymer theory that have intuitive, clearly-defined dynamics and exhibit the essential properties that we are seeking to identify in MD simulations of real biomolecules. We then apply spectral clustering, an algorithm particularly well-suited for clustering polymer structures, to our models and MD simulations of several intrinsically disordered proteins. Clustering results for the polymer models provide clear evidence that the meta-stable and transitional conformations are detected by the algorithm. The results for the polymer models also help guide the analysis of the disordered protein simulations by comparing and contrasting the statistical properties of the extracted clusters. Conclusions We have developed a framework for validating the performance and utility of clustering algorithms for studying molecular biopolymer simulations that utilizes several analytic and dynamic polymer models which exhibit well-behaved dynamics including: meta-stable states, transition states, helical structures, and stochastic dynamics. We show that spectral clustering is robust to anomalies introduced by structural alignment and that different structural classes of intrinsically disordered proteins can be reliably discriminated from the clustering results. To our

  20. Characterization of Hydrophobic Interactions of Polymers with Water and Phospholipid Membranes Using Molecular Dynamics Simulations

    Science.gov (United States)

    Drenscko, Mihaela

    Polymers and lipid membranes are both essential soft materials. The structure and hydrophobicity/hydrophilicity of polymers, as well as the solvent they are embedded in, ultimately determines their size and shape. Understating the variation of shape of the polymer as well as its interactions with model biological membranes can assist in understanding the biocompatibility of the polymer itself. Computer simulations, in particular molecular dynamics, can aid in characterization of the interaction of polymers with solvent, as well as polymers with model membranes. In this thesis, molecular dynamics serve to describe polymer interactions with a solvent (water) and with a lipid membrane. To begin with, we characterize the hydrophobic collapse of single polystyrene chains in water using molecular dynamics simulations. Specifically, we calculate the potential of mean force for the collapse of a single polystyrene chain in water using metadynamics, comparing the results between all atomistic with coarse-grained molecular simulation. We next explore the scaling behavior of the collapsed globular shape at the minimum energy configuration, characterized by the radius of gyration, as a function of chain length. The exponent is close to one third, consistent with that predicted for a polymer chain in bad solvent. We also explore the scaling behavior of the Solvent Accessible Surface Area (SASA) as a function of chain length, finding a similar exponent for both all-atomistic and coarse-grained simulations. Furthermore, calculation of the local water density as a function of chain length near the minimum energy configuration suggests that intermediate chain lengths are more likely to form dewetted states, as compared to shorter or longer chain lengths. Next, in order to investigate the molecular interactions between single hydrophobic polymer chains and lipids in biological membranes and at lipid membrane/solvent interface, we perform a series of molecular dynamics simulations of

  1. A scalable healthcare information system based on a service-oriented architecture.

    Science.gov (United States)

    Yang, Tzu-Hsiang; Sun, Yeali S; Lai, Feipei

    2011-06-01

    Many existing healthcare information systems are composed of a number of heterogeneous systems and face the important issue of system scalability. This paper first describes the comprehensive healthcare information systems used in National Taiwan University Hospital (NTUH) and then presents a service-oriented architecture (SOA)-based healthcare information system (HIS) based on the service standard HL7. The proposed architecture focuses on system scalability, in terms of both hardware and software. Moreover, we describe how scalability is implemented in rightsizing, service groups, databases, and hardware scalability. Although SOA-based systems sometimes display poor performance, through a performance evaluation of our HIS based on SOA, the average response time for outpatient, inpatient, and emergency HL7Central systems are 0.035, 0.04, and 0.036 s, respectively. The outpatient, inpatient, and emergency WebUI average response times are 0.79, 1.25, and 0.82 s. The scalability of the rightsizing project and our evaluation results show that the SOA HIS we propose provides evidence that SOA can provide system scalability and sustainability in a highly demanding healthcare information system.

  2. Incorporation of quantum statistical features in molecular dynamics

    International Nuclear Information System (INIS)

    Ohnishi, Akira; Randrup, J.

    1995-01-01

    We formulate a method for incorporating quantum fluctuations into molecular-dynamics simulations of many-body systems, such as those employed for energetic nuclear collision processes. Based on Fermi's Golden Rule, we allow spontaneous transitions to occur between the wave packets which are not energy eigenstates. The ensuing diffusive evolution in the space of the wave packet parameters exhibits appealing physical properties, including relaxation towards quantum-statistical equilibrium. (author)

  3. Molecular Dynamics Simulation of Binary Fluid in a Nanochannel

    International Nuclear Information System (INIS)

    Mullick, Shanta; Ahluwalia, P. K.; Pathania, Y.

    2011-01-01

    This paper presents the results from a molecular dynamics simulation of binary fluid (mixture of argon and krypton) in the nanochannel flow. The computational software LAMMPS is used for carrying out the molecular dynamics simulations. Binary fluids of argon and krypton with varying concentration of atom species were taken for two densities 0.65 and 0.45. The fluid flow takes place between two parallel plates and is bounded by horizontal walls in one direction and periodic boundary conditions are imposed in the other two directions. To drive the flow, a constant force is applied in one direction. Each fluid atom interacts with other fluid atoms and wall atoms through Week-Chandler-Anderson (WCA) potential. The velocity profile has been looked at for three nanochannel widths i.e for 12σ, 14σ and 16σ and also for the different concentration of two species. The velocity profile of the binary fluid predicted by the simulations agrees with the quadratic shape of the analytical solution of a Poiseuille flow in continuum theory.

  4. Molecular dynamics simulations of single siloxane dendrimers: Molecular structure and intramolecular mobility of terminal groups

    Science.gov (United States)

    Kurbatov, A. O.; Balabaev, N. K.; Mazo, M. A.; Kramarenko, E. Yu.

    2018-01-01

    Molecular dynamics simulations of two types of isolated siloxane dendrimers of various generations (from the 2nd to the 8th) have been performed for temperatures ranging from 150 K to 600 K. The first type of dendrimer molecules has short spacers consisting of a single oxygen atom. In the dendrimers of the second type, spacers are longer and comprised of two oxygen atoms separated by a single silicon atom. A comparative analysis of molecular macroscopic parameters such as the gyration radius and the shape factor as well as atom distributions within dendrimer interior has been performed for varying generation number, temperature, and spacer length. It has been found that the short-spacer dendrimers of the 7th and 8th generations have a stressed central part with elongated bonds and deformed valence angles. Investigation of the time evolution of radial displacements of the terminal Si atoms has shown that a fraction of the Si groups have a reduced mobility. Therefore, rather long time trajectories (of the order of tens of nanoseconds) are required to study dendrimer intramolecular dynamics.

  5. Dynamical heterogeneities of rotational motion in room temperature ionic liquids evidenced by molecular dynamics simulations

    Science.gov (United States)

    Usui, Kota; Hunger, Johannes; Bonn, Mischa; Sulpizi, Marialore

    2018-05-01

    Room temperature ionic liquids (RTILs) have been shown to exhibit spatial heterogeneity or structural heterogeneity in the sense that they form hydrophobic and ionic domains. Yet studies of the relationship between this structural heterogeneity and the ˜picosecond motion of the molecular constituents remain limited. In order to obtain insight into the time scales relevant to this structural heterogeneity, we perform molecular dynamics simulations of a series of RTILs. To investigate the relationship between the structures, i.e., the presence of hydrophobic and ionic domains, and the dynamics, we gradually increase the size of the hydrophobic part of the cation from ethylammonium nitrate (EAN), via propylammonium nitrate (PAN), to butylammonium nitrate (BAN). The two ends of the organic cation, namely, the charged Nhead-H group and the hydrophobic Ctail-H group, exhibit rotational dynamics on different time scales, evidencing dynamical heterogeneity. The dynamics of the Nhead-H group is slower because of the strong coulombic interaction with the nitrate counter-ionic anions, while the dynamics of the Ctail-H group is faster because of the weaker van der Waals interaction with the surrounding atoms. In particular, the rotation of the Nhead-H group slows down with increasing cationic chain length, while the rotation of the Ctail-H group shows little dependence on the cationic chain length, manifesting that the dynamical heterogeneity is enhanced with a longer cationic chain. The slowdown of the Nhead-H group with increasing cationic chain length is associated with a lower number of nitrate anions near the Nhead-H group, which presumably results in the increase of the energy barrier for the rotation. The sensitivity of the Nhead-H rotation to the number of surrounding nitrate anions, in conjunction with the varying number of nitrate anions, gives rise to a broad distribution of Nhead-H reorientation times. Our results suggest that the asymmetry of the cations and the

  6. Molecular dynamics simulation of carbon molecular sieve preparation for air separation

    International Nuclear Information System (INIS)

    Yaghoobpour, Elham; Ahmadpour, Ali; Farhadian, Nafiseh; Shariaty-Niassar, Mojtaba

    2015-01-01

    Carbon deposition process on activated carbon (AC) in order to produce carbon molecular sieve (CMS) was simulated using molecular dynamics simulation. The proposed activated carbon for simulation includes micropores with different characteristic diameters and lengths. Three different temperatures of 773 K, 973 K, and 1,273 K were selected to investigate the optimum deposition temperature. Simulation results show that the carbon deposition process at 973 K creates the best adsorbent structure. While at lower temperature some micropore openings are blocked with carbon atoms, at higher temperature the number of deposited carbons on the micropores does not change significantly. Also, carbon deposition process confirms the pseudo-second-order kinetic model with an endothermic behavior. To evaluate the sieving property of adsorbent products, nitrogen and oxygen adsorption on the initial and final adsorbent products are examined. Results show that there is not any considerable difference between the equilibrium adsorption amounts of nitrogen and oxygen on the initial and final adsorbents especially at low pressure (P<10 atm). Although, adsorption kinetics curves of these gases change significantly after the carbon deposition process in comparison with the initial sample. These observations indicate that the final adsorbent has high selectivity towards oxygen compared with the nitrogen, so it can be called a carbon molecular sieve. All simulated results are in good agreement with experiments

  7. Molecular dynamics simulation of carbon molecular sieve preparation for air separation

    Energy Technology Data Exchange (ETDEWEB)

    Yaghoobpour, Elham; Ahmadpour, Ali; Farhadian, Nafiseh [Ferdowsi University of Mashhad, Mashhad (Iran, Islamic Republic of); Shariaty-Niassar, Mojtaba [University of Tehran, Tehran(Iran, Islamic Republic of)

    2015-03-15

    Carbon deposition process on activated carbon (AC) in order to produce carbon molecular sieve (CMS) was simulated using molecular dynamics simulation. The proposed activated carbon for simulation includes micropores with different characteristic diameters and lengths. Three different temperatures of 773 K, 973 K, and 1,273 K were selected to investigate the optimum deposition temperature. Simulation results show that the carbon deposition process at 973 K creates the best adsorbent structure. While at lower temperature some micropore openings are blocked with carbon atoms, at higher temperature the number of deposited carbons on the micropores does not change significantly. Also, carbon deposition process confirms the pseudo-second-order kinetic model with an endothermic behavior. To evaluate the sieving property of adsorbent products, nitrogen and oxygen adsorption on the initial and final adsorbent products are examined. Results show that there is not any considerable difference between the equilibrium adsorption amounts of nitrogen and oxygen on the initial and final adsorbents especially at low pressure (P<10 atm). Although, adsorption kinetics curves of these gases change significantly after the carbon deposition process in comparison with the initial sample. These observations indicate that the final adsorbent has high selectivity towards oxygen compared with the nitrogen, so it can be called a carbon molecular sieve. All simulated results are in good agreement with experiments.

  8. Molecular dynamics simulation of bubble nucleation in explosive boiling

    International Nuclear Information System (INIS)

    Zou Yu; Chinese Academy of Sciences, Beijing; Huai Xiulan; Liang Shiqiang

    2009-01-01

    Molecular dynamics (MD) simulation is carried out for the bubble nucleation of liquid nitrogen in explosive boiling. The heat is transferred into the simulation system by rescaling the velocity of the molecules. The results indicate that the initial equilibrium temperature of liquid and molecular cluster size affect the energy conversion in the process of bubble nucleation. The potential energy of the system violently varies at the beginning of the bubble nucleation, and then varies around a fixed value. At the end of bubble nucleation, the potential energy of the system slowly increases. In the bubble nucleation of explosive boiling, the lower the initial equilibrium temperature, the larger the size of the molecular cluster, and the more the heat transferred into the system of the simulation cell, causing the increase potential energy in a larger range. (authors)

  9. Hydration dynamics in water clusters via quantum molecular dynamics simulations

    Energy Technology Data Exchange (ETDEWEB)

    Turi, László, E-mail: turi@chem.elte.hu [Department of Physical Chemistry, Eötvös Loránd University, Budapest 112, P. O. Box 32, H-1518 (Hungary)

    2014-05-28

    We have investigated the hydration dynamics in size selected water clusters with n = 66, 104, 200, 500, and 1000 water molecules using molecular dynamics simulations. To study the most fundamental aspects of relaxation phenomena in clusters, we choose one of the simplest, still realistic, quantum mechanically treated test solute, an excess electron. The project focuses on the time evolution of the clusters following two processes, electron attachment to neutral equilibrated water clusters and electron detachment from an equilibrated water cluster anion. The relaxation dynamics is significantly different in the two processes, most notably restoring the equilibrium final state is less effective after electron attachment. Nevertheless, in both scenarios only minor cluster size dependence is observed. Significantly different relaxation patterns characterize electron detachment for interior and surface state clusters, interior state clusters relaxing significantly faster. This observation may indicate a potential way to distinguish surface state and interior state water cluster anion isomers experimentally. A comparison of equilibrium and non-equilibrium trajectories suggests that linear response theory breaks down for electron attachment at 200 K, but the results converge to reasonable agreement at higher temperatures. Relaxation following electron detachment clearly belongs to the linear regime. Cluster relaxation was also investigated using two different computational models, one preferring cavity type interior states for the excess electron in bulk water, while the other simulating non-cavity structure. While the cavity model predicts appearance of several different hydrated electron isomers in agreement with experiment, the non-cavity model locates only cluster anions with interior excess electron distribution. The present simulations show that surface isomers computed with the cavity predicting potential show similar dynamical behavior to the interior clusters of

  10. Molecular dynamics of liquid crystals

    Science.gov (United States)

    Sarman, Sten

    1997-02-01

    We derive Green-Kubo relations for the viscosities of a nematic liquid crystal. The derivation is based on the application of a Gaussian constraint algorithm that makes the director angular velocity of a liquid crystal a constant of motion. Setting this velocity equal to zero means that a director-based coordinate system becomes an inertial frame and that the constraint torques do not do any work on the system. The system consequently remains in equilibrium. However, one generates a different equilibrium ensemble. The great advantage of this ensemble is that the Green-Kubo relations for the viscosities become linear combinations of time correlation function integrals, whereas they are complicated rational functions in the conventional canonical ensemble. This facilitates the numerical evaluation of the viscosities by molecular dynamics simulations.

  11. Molecular dynamics simulations reveal the conformational dynamics of Arabidopsis thaliana BRI1 and BAK1 receptor-like kinases.

    Science.gov (United States)

    Moffett, Alexander S; Bender, Kyle W; Huber, Steven C; Shukla, Diwakar

    2017-07-28

    The structural motifs responsible for activation and regulation of eukaryotic protein kinases in animals have been studied extensively in recent years, and a coherent picture of their activation mechanisms has begun to emerge. In contrast, non-animal eukaryotic protein kinases are not as well understood from a structural perspective, representing a large knowledge gap. To this end, we investigated the conformational dynamics of two key Arabidopsis thaliana receptor-like kinases, brassinosteroid-insensitive 1 (BRI1) and BRI1-associated kinase 1 (BAK1), through extensive molecular dynamics simulations of their fully phosphorylated kinase domains. Molecular dynamics simulations calculate the motion of each atom in a protein based on classical approximations of interatomic forces, giving researchers insight into protein function at unparalleled spatial and temporal resolutions. We found that in an otherwise "active" BAK1 the αC helix is highly disordered, a hallmark of deactivation, whereas the BRI1 αC helix is moderately disordered and displays swinging behavior similar to numerous animal kinases. An analysis of all known sequences in the A. thaliana kinome found that αC helix disorder may be a common feature of plant kinases. © 2017 by The American Society for Biochemistry and Molecular Biology, Inc.

  12. JPEG2000-Compatible Scalable Scheme for Wavelet-Based Video Coding

    Directory of Open Access Journals (Sweden)

    Thomas André

    2007-03-01

    Full Text Available We present a simple yet efficient scalable scheme for wavelet-based video coders, able to provide on-demand spatial, temporal, and SNR scalability, and fully compatible with the still-image coding standard JPEG2000. Whereas hybrid video coders must undergo significant changes in order to support scalability, our coder only requires a specific wavelet filter for temporal analysis, as well as an adapted bit allocation procedure based on models of rate-distortion curves. Our study shows that scalably encoded sequences have the same or almost the same quality than nonscalably encoded ones, without a significant increase in complexity. A full compatibility with Motion JPEG2000, which tends to be a serious candidate for the compression of high-definition video sequences, is ensured.

  13. JPEG2000-Compatible Scalable Scheme for Wavelet-Based Video Coding

    Directory of Open Access Journals (Sweden)

    André Thomas

    2007-01-01

    Full Text Available We present a simple yet efficient scalable scheme for wavelet-based video coders, able to provide on-demand spatial, temporal, and SNR scalability, and fully compatible with the still-image coding standard JPEG2000. Whereas hybrid video coders must undergo significant changes in order to support scalability, our coder only requires a specific wavelet filter for temporal analysis, as well as an adapted bit allocation procedure based on models of rate-distortion curves. Our study shows that scalably encoded sequences have the same or almost the same quality than nonscalably encoded ones, without a significant increase in complexity. A full compatibility with Motion JPEG2000, which tends to be a serious candidate for the compression of high-definition video sequences, is ensured.

  14. A molecular dynamics approach to barrodiffusion

    Science.gov (United States)

    Cooley, James; Marciante, Mathieu; Murillo, Michael

    2016-10-01

    Unexpected phenomena in the reaction rates for Inertial Confinement Fusion (ICF) capsules have led to a renewed interest in the thermo-dynamically driven diffusion process for the past 10 years, often described collectively as barodiffusion. In the current context, barodiffusion would manifest as a process that separates ions of differing mass and charge ratios due to pressure and temperature gradients set-up through shock structures in the capsule core. Barrodiffusion includes additional mass transfer terms that account for the irreversible transport of species due to gradients in the system, both thermodynamic and electric e.g, i = - ρD [ ∇c +kp ∇ln(pi) +kT(i) ∇ln(Ti) +kt(e) ∇ln(Te) +eke/Ti ∇ϕ ] . Several groups have attacked this phenomena using continuum scale models and supplemented with kinetic theory to derive coefficients for the different diffusion terms based on assumptions about the collisional processes. In contrast, we have applied a molecular dynamics (MD) simulation to this system to gain a first-principle understanding of the rate kinetics and to assess the accuracy of the differin

  15. A molecular dynamics study of the effects of fast molecular motions on solid-state NMR parameters

    Czech Academy of Sciences Publication Activity Database

    Dračínský, Martin; Hodgkinson, P.

    2013-01-01

    Roč. 15, č. 43 (2013), s. 8705-8712 ISSN 1466-8033 Grant - others:Seventh Framework Programme of the European Union(XE) FP7-299242 People Institutional support: RVO:61388963 Keywords : molecular dynamics * DFT calculations * NMR spectroscopy Subject RIV: CC - Organic Chemistry Impact factor: 3.858, year: 2013

  16. A Scalable Framework and Prototype for CAS e-Science

    Directory of Open Access Journals (Sweden)

    Yuanchun Zhou

    2007-07-01

    Full Text Available Based on the Small-World model of CAS e-Science and the power low of Internet, this paper presents a scalable CAS e-Science Grid framework based on virtual region called Virtual Region Grid Framework (VRGF. VRGF takes virtual region and layer as logic manage-unit. In VRGF, the mode of intra-virtual region is pure P2P, and the model of inter-virtual region is centralized. Therefore, VRGF is decentralized framework with some P2P properties. Further more, VRGF is able to achieve satisfactory performance on resource organizing and locating at a small cost, and is well adapted to the complicated and dynamic features of scientific collaborations. We have implemented a demonstration VRGF based Grid prototype—SDG.

  17. Insights into structural and dynamical features of water at halloysite interfaces probed by DFT and classical molecular dynamics simulations.

    Science.gov (United States)

    Presti, Davide; Pedone, Alfonso; Mancini, Giordano; Duce, Celia; Tiné, Maria Rosaria; Barone, Vincenzo

    2016-01-21

    Density functional theory calculations and classical molecular dynamics simulations have been used to investigate the structure and dynamics of water molecules on kaolinite surfaces and confined in the interlayer of a halloysite model of nanometric dimension. The first technique allowed us to accurately describe the structure of the tetrahedral-octahedral slab of kaolinite in vacuum and in interaction with water molecules and to assess the performance of two widely employed empirical force fields to model water/clay interfaces. Classical molecular dynamics simulations were used to study the hydrogen bond network structure and dynamics of water adsorbed on kaolinite surfaces and confined in the halloysite interlayer. The results are in nice agreement with the few experimental data available in the literature, showing a pronounced ordering and reduced mobility of water molecules at the hydrophilic octahedral surfaces of kaolinite and confined in the halloysite interlayer, with respect to water interacting with the hydrophobic tetrahedral surfaces and in the bulk. Finally, this investigation provides new atomistic insights into the structural and dynamical properties of water-clay interfaces, which are of fundamental importance for both natural processes and industrial applications.

  18. Molecular-dynamics Simulation-based Cohesive Zone Representation of Intergranular Fracture Processes in Aluminum

    Science.gov (United States)

    Yamakov, Vesselin I.; Saether, Erik; Phillips, Dawn R.; Glaessgen, Edward H.

    2006-01-01

    A traction-displacement relationship that may be embedded into a cohesive zone model for microscale problems of intergranular fracture is extracted from atomistic molecular-dynamics simulations. A molecular-dynamics model for crack propagation under steady-state conditions is developed to analyze intergranular fracture along a flat 99 [1 1 0] symmetric tilt grain boundary in aluminum. Under hydrostatic tensile load, the simulation reveals asymmetric crack propagation in the two opposite directions along the grain boundary. In one direction, the crack propagates in a brittle manner by cleavage with very little or no dislocation emission, and in the other direction, the propagation is ductile through the mechanism of deformation twinning. This behavior is consistent with the Rice criterion for cleavage vs. dislocation blunting transition at the crack tip. The preference for twinning to dislocation slip is in agreement with the predictions of the Tadmor and Hai criterion. A comparison with finite element calculations shows that while the stress field around the brittle crack tip follows the expected elastic solution for the given boundary conditions of the model, the stress field around the twinning crack tip has a strong plastic contribution. Through the definition of a Cohesive-Zone-Volume-Element an atomistic analog to a continuum cohesive zone model element - the results from the molecular-dynamics simulation are recast to obtain an average continuum traction-displacement relationship to represent cohesive zone interaction along a characteristic length of the grain boundary interface for the cases of ductile and brittle decohesion. Keywords: Crack-tip plasticity; Cohesive zone model; Grain boundary decohesion; Intergranular fracture; Molecular-dynamics simulation

  19. Orbital free ab initio molecular dynamics simulation study of some static and dynamic properties of liquid noble metals

    Directory of Open Access Journals (Sweden)

    G.M. Bhuiyan

    2012-10-01

    Full Text Available Several static and dynamic properties of liquid Cu, Ag and Au at thermodynamic states near their respective melting points, have been evaluated by means of the orbital free ab-initio molecular dynamics simulation method. The calculated static structure shows good agreement with the available X-ray and neutron diffraction data. As for the dynamic properties, the calculated dynamic structure factors point to the existence of collective density excitations along with a positive dispersion for l-Cu and l-Ag. Several transport coefficients have been obtained which show a reasonable agreement with the available experimental data.

  20. New technique of identifying the hierarchy of dynamic domains in proteins using a method of molecular dynamics simulations

    Directory of Open Access Journals (Sweden)

    Yesylevskyy S. O.

    2010-04-01

    Full Text Available Aim. Despite a large number of existing domain identification techniques there is no universally accepted method, which identifies the hierarchy of dynamic domains using the data of molecular dynamics (MD simulations. The goal of this work is to develop such technique. Methods. The dynamic domains are identified by eliminating systematic motions from MD trajectories recursively in a model-free manner. Results. The technique called the Hierarchical Domain-Wise Alignment (HDWA to identify hierarchically organized dynamic domains in proteins using the MD trajectories has been developed. Conclusion. A new method of domain identification in proteins is proposed

  1. Orientation and conformation of a lipase at an interface studied by molecular dynamics simulations

    DEFF Research Database (Denmark)

    Jensen, Morten Østergaard; Jensen, T.R.; Kjær, Kristian

    2002-01-01

    Electron density profiles calculated from molecular dynamics trajectories are used to deduce the orientation and conformation of Thermomyces lanuginosa lipase and a mutant adsorbed at an air-water interface. It is demonstrated that the profiles display distinct fine structures, which uniquely...... characterize enzyme orientation and conformation. The density profiles are, on the nanosecond timescale, determined by the average enzyme conformation. We outline a Computational scheme that from a single molecular dynamics trajectory allows for extraction of electron density profiles referring to different...

  2. Declarative and Scalable Selection for Map Visualizations

    DEFF Research Database (Denmark)

    Kefaloukos, Pimin Konstantin Balic

    and is itself a source and cause of prolific data creation. This calls for scalable map processing techniques that can handle the data volume and which play well with the predominant data models on the Web. (4) Maps are now consumed around the clock by a global audience. While historical maps were singleuser......-defined constraints as well as custom objectives. The purpose of the language is to derive a target multi-scale database from a source database according to holistic specifications. (b) The Glossy SQL compiler allows Glossy SQL to be scalably executed in a spatial analytics system, such as a spatial relational......, there are indications that the method is scalable for databases that contain millions of records, especially if the target language of the compiler is substituted by a cluster-ready variant of SQL. While several realistic use cases for maps have been implemented in CVL, additional non-geographic data visualization uses...

  3. Scalable robotic biofabrication of tissue spheroids

    International Nuclear Information System (INIS)

    Mehesz, A Nagy; Hajdu, Z; Visconti, R P; Markwald, R R; Mironov, V; Brown, J; Beaver, W; Da Silva, J V L

    2011-01-01

    Development of methods for scalable biofabrication of uniformly sized tissue spheroids is essential for tissue spheroid-based bioprinting of large size tissue and organ constructs. The most recent scalable technique for tissue spheroid fabrication employs a micromolded recessed template prepared in a non-adhesive hydrogel, wherein the cells loaded into the template self-assemble into tissue spheroids due to gravitational force. In this study, we present an improved version of this technique. A new mold was designed to enable generation of 61 microrecessions in each well of a 96-well plate. The microrecessions were seeded with cells using an EpMotion 5070 automated pipetting machine. After 48 h of incubation, tissue spheroids formed at the bottom of each microrecession. To assess the quality of constructs generated using this technology, 600 tissue spheroids made by this method were compared with 600 spheroids generated by the conventional hanging drop method. These analyses showed that tissue spheroids fabricated by the micromolded method are more uniform in diameter. Thus, use of micromolded recessions in a non-adhesive hydrogel, combined with automated cell seeding, is a reliable method for scalable robotic fabrication of uniform-sized tissue spheroids.

  4. Scalable robotic biofabrication of tissue spheroids

    Energy Technology Data Exchange (ETDEWEB)

    Mehesz, A Nagy; Hajdu, Z; Visconti, R P; Markwald, R R; Mironov, V [Advanced Tissue Biofabrication Center, Department of Regenerative Medicine and Cell Biology, Medical University of South Carolina, Charleston, SC (United States); Brown, J [Department of Mechanical Engineering, Clemson University, Clemson, SC (United States); Beaver, W [York Technical College, Rock Hill, SC (United States); Da Silva, J V L, E-mail: mironovv@musc.edu [Renato Archer Information Technology Center-CTI, Campinas (Brazil)

    2011-06-15

    Development of methods for scalable biofabrication of uniformly sized tissue spheroids is essential for tissue spheroid-based bioprinting of large size tissue and organ constructs. The most recent scalable technique for tissue spheroid fabrication employs a micromolded recessed template prepared in a non-adhesive hydrogel, wherein the cells loaded into the template self-assemble into tissue spheroids due to gravitational force. In this study, we present an improved version of this technique. A new mold was designed to enable generation of 61 microrecessions in each well of a 96-well plate. The microrecessions were seeded with cells using an EpMotion 5070 automated pipetting machine. After 48 h of incubation, tissue spheroids formed at the bottom of each microrecession. To assess the quality of constructs generated using this technology, 600 tissue spheroids made by this method were compared with 600 spheroids generated by the conventional hanging drop method. These analyses showed that tissue spheroids fabricated by the micromolded method are more uniform in diameter. Thus, use of micromolded recessions in a non-adhesive hydrogel, combined with automated cell seeding, is a reliable method for scalable robotic fabrication of uniform-sized tissue spheroids.

  5. Molecular dynamics modeling and simulation of void growth in two dimensions

    Science.gov (United States)

    Chang, H.-J.; Segurado, J.; Rodríguez de la Fuente, O.; Pabón, B. M.; LLorca, J.

    2013-10-01

    The mechanisms of growth of a circular void by plastic deformation were studied by means of molecular dynamics in two dimensions (2D). While previous molecular dynamics (MD) simulations in three dimensions (3D) have been limited to small voids (up to ≈10 nm in radius), this strategy allows us to study the behavior of voids of up to 100 nm in radius. MD simulations showed that plastic deformation was triggered by the nucleation of dislocations at the atomic steps of the void surface in the whole range of void sizes studied. The yield stress, defined as stress necessary to nucleate stable dislocations, decreased with temperature, but the void growth rate was not very sensitive to this parameter. Simulations under uniaxial tension, uniaxial deformation and biaxial deformation showed that the void growth rate increased very rapidly with multiaxiality but it did not depend on the initial void radius. These results were compared with previous 3D MD and 2D dislocation dynamics simulations to establish a map of mechanisms and size effects for plastic void growth in crystalline solids.

  6. Molecular dynamics modeling and simulation of void growth in two dimensions

    International Nuclear Information System (INIS)

    Chang, H-J; Segurado, J; LLorca, J; Rodríguez de la Fuente, O; Pabón, B M

    2013-01-01

    The mechanisms of growth of a circular void by plastic deformation were studied by means of molecular dynamics in two dimensions (2D). While previous molecular dynamics (MD) simulations in three dimensions (3D) have been limited to small voids (up to ≈10 nm in radius), this strategy allows us to study the behavior of voids of up to 100 nm in radius. MD simulations showed that plastic deformation was triggered by the nucleation of dislocations at the atomic steps of the void surface in the whole range of void sizes studied. The yield stress, defined as stress necessary to nucleate stable dislocations, decreased with temperature, but the void growth rate was not very sensitive to this parameter. Simulations under uniaxial tension, uniaxial deformation and biaxial deformation showed that the void growth rate increased very rapidly with multiaxiality but it did not depend on the initial void radius. These results were compared with previous 3D MD and 2D dislocation dynamics simulations to establish a map of mechanisms and size effects for plastic void growth in crystalline solids. (paper)

  7. Ab initio molecular dynamics: basic concepts, current trends and novel applications

    International Nuclear Information System (INIS)

    Tuckerman, Mark E

    2002-01-01

    The field of ab initio molecular dynamics (AIMD), in which finite temperature molecular dynamics (MD) trajectories are generated with forces obtained from accurate 'on the fly' electronic structure calculations, is a rapidly evolving and growing technology that allows chemical processes in condensed phases to be studied in an accurate and unbiased way. This article is intended to present the basics of the AIMD method as well as to provide a broad survey of the state of the art of the field and showcase some of its capabilities. Beginning with a derivation of the method from the Born-Oppenheimer approximation, issues including the density functional representation of electronic structure, basis sets, calculation of observables and the Car-Parrinello extended Lagrangian algorithm are discussed. A number of example applications, including liquid structure and dynamics and aqueous proton transport, are presented in order to highlight some of the current capabilities of the approach. Finally, advanced topics such as inclusion of nuclear quantum effects, excited states and scaling issues are addressed. (topical review)

  8. Molecular Dynamics Simulations of Tensile Behavior of Copper

    OpenAIRE

    Sainath, G.; Srinivasan, V. S.; Choudhary, B. K.; Mathew, M. D.; Jayakumar, T.

    2014-01-01

    Molecular dynamics simulations on tensile deformation of initially defect free single crystal copper nanowire oriented in {100} has been carried out at 10 K under adiabatic and isothermal loading conditions. The tensile behaviour was characterized by sharp rise in stress in elastic regime followed by sudden drop at the point of dislocation nucleation. The important finding is that the variation in dislocation density is correlated with the observed stress-strain response. Several interesting ...

  9. Accelerating Molecular Dynamic Simulation on Graphics Processing Units

    Science.gov (United States)

    Friedrichs, Mark S.; Eastman, Peter; Vaidyanathan, Vishal; Houston, Mike; Legrand, Scott; Beberg, Adam L.; Ensign, Daniel L.; Bruns, Christopher M.; Pande, Vijay S.

    2009-01-01

    We describe a complete implementation of all-atom protein molecular dynamics running entirely on a graphics processing unit (GPU), including all standard force field terms, integration, constraints, and implicit solvent. We discuss the design of our algorithms and important optimizations needed to fully take advantage of a GPU. We evaluate its performance, and show that it can be more than 700 times faster than a conventional implementation running on a single CPU core. PMID:19191337

  10. Molecular dynamics simulation of cascade damage in gold

    International Nuclear Information System (INIS)

    Alonso, E.; Caturla, M.J.; Tang, M.; Huang, H.; Diaz de la Rubia, T.

    1997-01-01

    High-energy cascades have been simulated in gold using molecular dynamics with a modified embedded atom method potential. The results show that both vacancy and interstitial clusters form with high probability as a result of intracascade processes. The formation of clusters has been interpreted in terms of the high pressures generated in the core of the cascade during the early stages. The authors provide evidence that correlation between interstitial and vacancy clustering exists

  11. Architectures and Applications for Scalable Quantum Information Systems

    Science.gov (United States)

    2007-01-01

    Gershenfeld and I. Chuang. Quantum computing with molecules. Scientific American, June 1998. [16] A. Globus, D. Bailey, J. Han, R. Jaffe, C. Levit , R...AFRL-IF-RS-TR-2007-12 Final Technical Report January 2007 ARCHITECTURES AND APPLICATIONS FOR SCALABLE QUANTUM INFORMATION SYSTEMS...NUMBER 5b. GRANT NUMBER FA8750-01-2-0521 4. TITLE AND SUBTITLE ARCHITECTURES AND APPLICATIONS FOR SCALABLE QUANTUM INFORMATION SYSTEMS 5c

  12. Ab initio molecular dynamics simulation of laser melting of silicon

    NARCIS (Netherlands)

    Silvestrelli, P.-L.; Alavi, A.; Parrinello, M.; Frenkel, D.

    1996-01-01

    The method of ab initio molecular dynamics, based on finite temperature density functional theory, is used to simulate laser heating of crystal silicon. We have found that a high concentration of excited electrons dramatically weakens the covalent bond. As a result, the system undergoes a melting

  13. Molecular dynamics simulations of bio-nano systems with MBN Explorer

    DEFF Research Database (Denmark)

    Yakubovich, Alexander V.; Solov'yov, Ilia; Solov'yov, Andrey V.

    2013-01-01

    We present results of molecular dynamics simulations performed using a multi-purpose computer code MBN Explorer. In particular we consider the process of laser induced acoustic desorption of lysine amino acids from the surface of a nickel foil. We analyze the rate of lysine desorption from...

  14. Toluene model for molecular dynamics simulations in the ranges 298

    NARCIS (Netherlands)

    Fioroni, M.; Vogt, D.

    2004-01-01

    An all-atom model for toluene is presented in the framework of classical molecular dynamics (MD). The model has been parametrized under the GROMOS96 force field to reproduce the physicochemical properties of the neat liquid. Four new atom types have been introduced, distinguishing between carbons

  15. Extending JPEG-LS for low-complexity scalable video coding

    DEFF Research Database (Denmark)

    Ukhanova, Anna; Sergeev, Anton; Forchhammer, Søren

    2011-01-01

    JPEG-LS, the well-known international standard for lossless and near-lossless image compression, was originally designed for non-scalable applications. In this paper we propose a scalable modification of JPEG-LS and compare it with the leading image and video coding standards JPEG2000 and H.264/SVC...

  16. Molecular Dynamics Study of Water Molecules in Interlayer of 14 ^|^Aring; Tobermorite

    KAUST Repository

    Yoon, Seyoon

    2013-01-01

    The molecular structure and dynamics of interlayer water of 14 Å tobermorite are investigated based on molecular dynamics (MD) simulations. Calculated structural parameters of the interlayer water configuration are in good agreement with current knowledge of the refined structure. The MD simulations provide detailed information on the position and mobility of the hydrogen and oxygen of interlayer water, as well as its self-diffusion coefficient, through the interlayer of 14 Å tobermorite. Comparison of the MD simulation results at 100 and 300 K demonstrates that water molecules in the interlayer maintain their structure but change their mobility. The dominant configuration and self-diffusion coefficient of interlayer water are obtained in this study. Copyright © 2013 Japan Concrete Institute.

  17. Parallel computing and molecular dynamics of biological membranes

    International Nuclear Information System (INIS)

    La Penna, G.; Letardi, S.; Minicozzi, V.; Morante, S.; Rossi, G.C.; Salina, G.

    1998-01-01

    In this talk I discuss the general question of the portability of molecular dynamics codes for diffusive systems on parallel computers of the APE family. The intrinsic single precision of the today available platforms does not seem to affect the numerical accuracy of the simulations, while the absence of integer addressing from CPU to individual nodes puts strong constraints on possible programming strategies. Liquids can be satisfactorily simulated using the ''systolic'' method. For more complex systems, like the biological ones at which we are ultimately interested in, the ''domain decomposition'' approach is best suited to beat the quadratic growth of the inter-molecular computational time with the number of atoms of the system. The promising perspectives of using this strategy for extensive simulations of lipid bilayers are briefly reviewed. (orig.)

  18. The MOLDY short-range molecular dynamics package

    Science.gov (United States)

    Ackland, G. J.; D'Mellow, K.; Daraszewicz, S. L.; Hepburn, D. J.; Uhrin, M.; Stratford, K.

    2011-12-01

    We describe a parallelised version of the MOLDY molecular dynamics program. This Fortran code is aimed at systems which may be described by short-range potentials and specifically those which may be addressed with the embedded atom method. This includes a wide range of transition metals and alloys. MOLDY provides a range of options in terms of the molecular dynamics ensemble used and the boundary conditions which may be applied. A number of standard potentials are provided, and the modular structure of the code allows new potentials to be added easily. The code is parallelised using OpenMP and can therefore be run on shared memory systems, including modern multicore processors. Particular attention is paid to the updates required in the main force loop, where synchronisation is often required in OpenMP implementations of molecular dynamics. We examine the performance of the parallel code in detail and give some examples of applications to realistic problems, including the dynamic compression of copper and carbon migration in an iron-carbon alloy. Program summaryProgram title: MOLDY Catalogue identifier: AEJU_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEJU_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: GNU General Public License version 2 No. of lines in distributed program, including test data, etc.: 382 881 No. of bytes in distributed program, including test data, etc.: 6 705 242 Distribution format: tar.gz Programming language: Fortran 95/OpenMP Computer: Any Operating system: Any Has the code been vectorised or parallelized?: Yes. OpenMP is required for parallel execution RAM: 100 MB or more Classification: 7.7 Nature of problem: Moldy addresses the problem of many atoms (of order 10 6) interacting via a classical interatomic potential on a timescale of microseconds. It is designed for problems where statistics must be gathered over a number of equivalent runs, such as

  19. First-Principles Molecular Dynamics Study on Helium- filled Carbon Nanotube

    International Nuclear Information System (INIS)

    Agusta, M K; Prasetiyo, I; Saputro, A G; Dipojono, H K; Maezono, R

    2016-01-01

    Investigation on carbon nanotube (CNT) filled by Helium (He) atoms is conducted using Density Functional Theory and Molecular Dynamics Simulation. It reveals that He atom is repelled by CNT's wall and find its stable position at the tube center. Vibrational analysis on modes corespond to radial inward and outward breathing movement of CNT shows that He filling tends to pull the CNT wall in inward direction. Furthermore, examination on C-C stretch mode reveals that the existence of He improve the stiffness of CNT's wall. Molecular dynamics calculations which are done on (3,3) and (5,5) nanotube with 0.25 gr/cm 3 and 0.5 gr/cm 3 He density at 300 K and 1500 K confirms the increase of stiffness of CNT wall by interaction with He atoms. Effects of variation of chirality, temperature and He density on CNT wall stiffness is also reported. (paper)

  20. Structural, dynamical, electronic, and bonding properties of laser-heated silicon: An ab initio molecular-dynamics study

    NARCIS (Netherlands)

    Silvestrelli, P.-L.; Alavi, A.; Parrinello, M.; Frenkel, D.

    1997-01-01

    The method of ab initio molecular dynamics, based on finite-temperature density-functional theory, is used to simulate laser heating of crystalline silicon. We found that a high concentration of excited electrons dramatically weakens the covalent bonding. As a result the system undergoes a melting

  1. A Langevin model for fluctuating contact angle behaviour parametrised using molecular dynamics.

    Science.gov (United States)

    Smith, E R; Müller, E A; Craster, R V; Matar, O K

    2016-12-06

    Molecular dynamics simulations are employed to develop a theoretical model to predict the fluid-solid contact angle as a function of wall-sliding speed incorporating thermal fluctuations. A liquid bridge between counter-sliding walls is studied, with liquid-vapour interface-tracking, to explore the impact of wall-sliding speed on contact angle. The behaviour of the macroscopic contact angle varies linearly over a range of capillary numbers beyond which the liquid bridge pinches off, a behaviour supported by experimental results. Nonetheless, the liquid bridge provides an ideal test case to study molecular scale thermal fluctuations, which are shown to be well described by Gaussian distributions. A Langevin model for contact angle is parametrised to incorporate the mean, fluctuation and auto-correlations over a range of sliding speeds and temperatures. The resulting equations can be used as a proxy for the fully-detailed molecular dynamics simulation allowing them to be integrated within a continuum-scale solver.

  2. Molecular Dynamics and Monte Carlo simulations resolve apparent diffusion rate differences for proteins confined in nanochannels

    Energy Technology Data Exchange (ETDEWEB)

    Tringe, J.W., E-mail: tringe2@llnl.gov [Lawrence Livermore National Laboratory, 7000 East Avenue, Livermore, CA (United States); Ileri, N. [Lawrence Livermore National Laboratory, 7000 East Avenue, Livermore, CA (United States); Department of Chemical Engineering & Materials Science, University of California, Davis, CA (United States); Levie, H.W. [Lawrence Livermore National Laboratory, 7000 East Avenue, Livermore, CA (United States); Stroeve, P.; Ustach, V.; Faller, R. [Department of Chemical Engineering & Materials Science, University of California, Davis, CA (United States); Renaud, P. [Swiss Federal Institute of Technology, Lausanne, (EPFL) (Switzerland)

    2015-08-18

    Highlights: • WGA proteins in nanochannels modeled by Molecular Dynamics and Monte Carlo. • Protein surface coverage characterized by atomic force microscopy. • Models indicate transport characteristics depend strongly on surface coverage. • Results resolve of a four orders of magnitude difference in diffusion coefficient values. - Abstract: We use Molecular Dynamics and Monte Carlo simulations to examine molecular transport phenomena in nanochannels, explaining four orders of magnitude difference in wheat germ agglutinin (WGA) protein diffusion rates observed by fluorescence correlation spectroscopy (FCS) and by direct imaging of fluorescently-labeled proteins. We first use the ESPResSo Molecular Dynamics code to estimate the surface transport distance for neutral and charged proteins. We then employ a Monte Carlo model to calculate the paths of protein molecules on surfaces and in the bulk liquid transport medium. Our results show that the transport characteristics depend strongly on the degree of molecular surface coverage. Atomic force microscope characterization of surfaces exposed to WGA proteins for 1000 s show large protein aggregates consistent with the predicted coverage. These calculations and experiments provide useful insight into the details of molecular motion in confined geometries.

  3. Scalable rule-based modelling of allosteric proteins and biochemical networks.

    Directory of Open Access Journals (Sweden)

    Julien F Ollivier

    2010-11-01

    Full Text Available Much of the complexity of biochemical networks comes from the information-processing abilities of allosteric proteins, be they receptors, ion-channels, signalling molecules or transcription factors. An allosteric protein can be uniquely regulated by each combination of input molecules that it binds. This "regulatory complexity" causes a combinatorial increase in the number of parameters required to fit experimental data as the number of protein interactions increases. It therefore challenges the creation, updating, and re-use of biochemical models. Here, we propose a rule-based modelling framework that exploits the intrinsic modularity of protein structure to address regulatory complexity. Rather than treating proteins as "black boxes", we model their hierarchical structure and, as conformational changes, internal dynamics. By modelling the regulation of allosteric proteins through these conformational changes, we often decrease the number of parameters required to fit data, and so reduce over-fitting and improve the predictive power of a model. Our method is thermodynamically grounded, imposes detailed balance, and also includes molecular cross-talk and the background activity of enzymes. We use our Allosteric Network Compiler to examine how allostery can facilitate macromolecular assembly and how competitive ligands can change the observed cooperativity of an allosteric protein. We also develop a parsimonious model of G protein-coupled receptors that explains functional selectivity and can predict the rank order of potency of agonists acting through a receptor. Our methodology should provide a basis for scalable, modular and executable modelling of biochemical networks in systems and synthetic biology.

  4. Molecular dynamics simulation of albite twinning and pericline twinning in low albite

    International Nuclear Information System (INIS)

    Li, Bin; Knowles, Kevin M

    2013-01-01

    Two twinning laws, the albite law and the pericline law, are the predominant growth twinning modes in triclinic plagioclase feldspars such as low albite, NaAlSi 3 O 8 , in which the aluminum and silicon atoms are in an ordered arrangement on the tetrahedral sites of the aluminosilicate framework. In the terminology used formally to describe deformation twinning in a triclinic lattice, these twin laws can be described as Type I and Type II twin laws, respectively, with the pericline twin law being conjugate to the albite twin law. In this study, twin boundaries have been constructed for low albite according to these two twinning laws and studied by molecular dynamics simulation. The results show that suitably constructed twin boundary models are quite stable for both albite twinning and pericline twinning during molecular dynamics simulation. The calculated twin boundary energy of an albite twin is significantly lower than that of a pericline twin, in accord with the experimental observation that albite twinning is the more commonly observed mode seen in plagioclase feldspars. The results of the molecular dynamics simulations also agree with conclusions from the prior work of Starkey that glide twinning in low albite is not favoured energetically. (paper)

  5. Initial Chemical Events in CL-20 Under Extreme Conditions: An Ab Initio Molecular Dynamics Study

    National Research Council Canada - National Science Library

    Isaev, Olexandr; Kholod, Yana; Gorb, Leonid; Qasim, Mohammad; Fredrickson, Herb; Leszczynski, Jerzy

    2006-01-01

    .... In the present study molecular structure, electrostatic potential, vibrational spectrum and dynamics of thermal decomposition of CL-20 have been investigated by static and dynamic methods of ab...

  6. Tracking nuclear wave-packet dynamics in molecular oxygen ions with few-cycle infrared laser pulses

    International Nuclear Information System (INIS)

    De, S.; Bocharova, I. A.; Magrakvelidze, M.; Ray, D.; Cao, W.; Thumm, U.; Cocke, C. L.; Bergues, B.; Kling, M. F.; Litvinyuk, I. V.

    2010-01-01

    We have tracked nuclear wave-packet dynamics in doubly charged states of molecular oxygen using few-cycle infrared laser pulses. Bound and dissociating wave packets were launched and subsequently probed via a pair of 8-fs pulses of 790 nm radiation. Ionic fragments from the dissociating molecules were monitored by velocity-map imaging. Pronounced oscillations in the delay-dependent kinetic energy release spectra were observed. The occurrence of vibrational revivals permits us to identify the potential curves of the O 2 dication which are most relevant to the molecular dynamics. These studies show the accessibility to the dynamics of such higher-charged molecules.

  7. Traffic and Quality Characterization of the H.264/AVC Scalable Video Coding Extension

    Directory of Open Access Journals (Sweden)

    Geert Van der Auwera

    2008-01-01

    Full Text Available The recent scalable video coding (SVC extension to the H.264/AVC video coding standard has unprecedented compression efficiency while supporting a wide range of scalability modes, including temporal, spatial, and quality (SNR scalability, as well as combined spatiotemporal SNR scalability. The traffic characteristics, especially the bit rate variabilities, of the individual layer streams critically affect their network transport. We study the SVC traffic statistics, including the bit rate distortion and bit rate variability distortion, with long CIF resolution video sequences and compare them with the corresponding MPEG-4 Part 2 traffic statistics. We consider (i temporal scalability with three temporal layers, (ii spatial scalability with a QCIF base layer and a CIF enhancement layer, as well as (iii quality scalability modes FGS and MGS. We find that the significant improvement in RD efficiency of SVC is accompanied by substantially higher traffic variabilities as compared to the equivalent MPEG-4 Part 2 streams. We find that separately analyzing the traffic of temporal-scalability only encodings gives reasonable estimates of the traffic statistics of the temporal layers embedded in combined spatiotemporal encodings and in the base layer of combined FGS-temporal encodings. Overall, we find that SVC achieves significantly higher compression ratios than MPEG-4 Part 2, but produces unprecedented levels of traffic variability, thus presenting new challenges for the network transport of scalable video.

  8. The Silica-Water Interface from the Analysis of Molecular Dynamic Simulations

    KAUST Repository

    Lardhi, Sheikha F.

    2013-01-01

    detailed understanding of the silica-water interface. In this study, we investigate the details of this interaction at microscopic level by analyzing trajectories obtained with ab initio molecular dynamic simulations. The system we consider consists of bulk

  9. Microscopic study of nuclear 'pasta' by quantum molecular dynamics

    International Nuclear Information System (INIS)

    Watanabe, Gentaro; Sato, Katsuhiko; Yasuoka, Kenji; Ebisuzaki, Toshikazu

    2002-01-01

    Structure of cold dense matter at subnuclear densities is investigated by quantum molecular dynamics (QMD) simulations. We succeeded in showing that the phases with slab-like and rod-like nuclei etc. and be formed dynamically from hot uniform nuclear matter without any assumptions on nuclear shape. We also observe intermediate phases, which has complicated nuclear shapes. Geometrical structures of matter are analyzed with Minkowski functionals, and it is found out that intermediate phases can be characterized as ones with negative Euler characteristic. Our result suggests the existence of these kinds of phases in addition to the simple 'pasta' phases in neutron star crusts. (author)

  10. Coalescence of silver unidimensional structures by molecular dynamics simulation

    International Nuclear Information System (INIS)

    Perez A, M.; Gutierrez W, C.E.; Mondragon, G.; Arenas, J.

    2007-01-01

    The study of nanoparticles coalescence and silver nano rods phenomena by means of molecular dynamics simulation under the thermodynamic laws is reported. In this work we focus ourselves to see the conditions under which the one can be given one dimension growth of silver nano rods for the coalescence phenomenon among two nano rods or one nano rod and one particle; what allows us to study those structural, dynamic and morphological properties of the silver nano rods to different thermodynamic conditions. The simulations are carried out using the Sutton-Chen potentials of interaction of many bodies that allow to obtain appropriate results with the real physical systems. (Author)

  11. Medicinal plant phytochemicals and their inhibitory activities against pancreatic lipase: molecular docking combined with molecular dynamics simulation approach

    OpenAIRE

    Ahmed, Bilal; Ali Ashfaq, Usman; Mirza, Muhammad Usman

    2017-01-01

    Obesity is the worst health risk worldwide, which is linked to a number of diseases. Pancreatic lipase is considered as an affective cause of obesity and can be a major target for controlling the obesity. The present study was designed to find out best phytochemicals against pancreatic lipase through molecular docking combined with molecular dynamics (MD) simulation. For this purpose, a total of 3770 phytochemicals were docked against pancreatic lipase and ranked them on the basis of binding ...

  12. Young Modulus of Crystalline Polyethylene from ab Initio Molecular Dynamics

    NARCIS (Netherlands)

    Hageman, J.C.L.; Meier, Robert J.; Heinemann, M.; Groot, R.A. de

    1997-01-01

    The Young modulus for crystalline polyethylene is calculated using ab initio molecular dynamics based on density functional theory in the local density approximation (DFT-LDA). This modulus, which can be seen as the ultimate value for the Young modulus of polyethylene fibers, is found to be 334 GPa.

  13. Infrared and Raman Spectroscopy of Liquid Water through "First-Principles" Many-Body Molecular Dynamics.

    Science.gov (United States)

    Medders, Gregory R; Paesani, Francesco

    2015-03-10

    Vibrational spectroscopy is a powerful technique to probe the structure and dynamics of water. However, deriving an unambiguous molecular-level interpretation of the experimental spectral features remains a challenge due to the complexity of the underlying hydrogen-bonding network. In this contribution, we present an integrated theoretical and computational framework (named many-body molecular dynamics or MB-MD) that, by systematically removing uncertainties associated with existing approaches, enables a rigorous modeling of vibrational spectra of water from quantum dynamical simulations. Specifically, we extend approaches used to model the many-body expansion of interaction energies to develop many-body representations of the dipole moment and polarizability of water. The combination of these "first-principles" representations with centroid molecular dynamics simulations enables the simulation of infrared and Raman spectra of liquid water under ambient conditions that, without relying on any ad hoc parameters, are in good agreement with the corresponding experimental results. Importantly, since the many-body energy, dipole, and polarizability surfaces employed in the simulations are derived independently from accurate fits to correlated electronic structure data, MB-MD allows for a systematic analysis of the calculated spectra in terms of both electronic and dynamical contributions. The present analysis suggests that, while MB-MD correctly reproduces both the shifts and the shapes of the main spectroscopic features, an improved description of quantum dynamical effects possibly combined with a dissociable water potential may be necessary for a quantitative representation of the OH stretch band.

  14. Reaction Ensemble Molecular Dynamics: Direct Simulation of the Dynamic Equilibrium Properties of Chemically Reacting Mixtures

    Czech Academy of Sciences Publication Activity Database

    Brennan, J.K.; Lísal, Martin; Gubbins, K.E.; Rice, B.M.

    2004-01-01

    Roč. 70, č. 6 (2004), 0611031-0611034 ISSN 1063-651X R&D Projects: GA ČR GA203/03/1588 Grant - others:NSF(US) CTS-0211792 Institutional research plan: CEZ:AV0Z4072921 Keywords : reacting systems * simulation * molecular dynamics Subject RIV: CF - Physical ; Theoretical Chemistry Impact factor: 2.352, year: 2004

  15. Structure and Interface Properties of Nanophase Ceramics: Multimillion Particle Molecular-Dynamics Simulations on Parallel Computer

    National Research Council Canada - National Science Library

    Kalia, Rajiv

    1997-01-01

    Large-scale molecular-dynamics (MD) simulations were performed to investigate: (1) sintering process, structural correlations, and mechanical behavior including dynamic fracture in microporous and nanophase Si3N4...

  16. Curvature effects on lipid packing and dynamics in liposomes revealed by coarse grained molecular dynamics simulations

    NARCIS (Netherlands)

    Risselada, H. Jelger; Marrink, Siewert J.

    2009-01-01

    The molecular packing details of lipids in planar bilayers are well characterized. For curved bilayers, however, little data is available. In this paper we study the effect of temperature and membrane composition on the structural and dynamical properties of a liposomal membrane in the limit of high

  17. Non-affine deformation in microstructure selection in solids: I. Molecular dynamics

    Energy Technology Data Exchange (ETDEWEB)

    Bhattacharya, Jayee; Paul, Arya; Sengupta, Surajit [S N Bose National Centre for Basic Sciences, Block JD, Sector III, Salt Lake, Calcutta 700 098 (India); Rao, Madan [Raman Research Institute, C V Raman Avenue, Bangalore 560 080 (India)

    2008-09-10

    We study the nucleation dynamics and microstructure selection in a model two-dimensional solid undergoing a square to rhombic transformation, using coarse-grained molecular dynamics (MD) simulations. We find a range of microstructures depending on the depth of quench. The transformations are accompanied by the creation of transient and localized non-affine zones (NAZ), which evolve with the rapidly moving parent-product interface. These plastic regions are created beyond a threshold stress, at a rate proportional to the local stress. We show that the dynamics of NAZs determines the selection of microstructure, including the ferrite and martensite.

  18. Scalable, full-colour and controllable chromotropic plasmonic printing

    OpenAIRE

    Xue, Jiancai; Zhou, Zhang-Kai; Wei, Zhiqiang; Su, Rongbin; Lai, Juan; Li, Juntao; Li, Chao; Zhang, Tengwei; Wang, Xue-Hua

    2015-01-01

    Plasmonic colour printing has drawn wide attention as a promising candidate for the next-generation colour-printing technology. However, an efficient approach to realize full colour and scalable fabrication is still lacking, which prevents plasmonic colour printing from practical applications. Here we present a scalable and full-colour plasmonic printing approach by combining conjugate twin-phase modulation with a plasmonic broadband absorber. More importantly, our approach also demonstrates ...

  19. Nanoparticle builder: new software for preparing nanoparticles for molecular dynamics simulations

    Czech Academy of Sciences Publication Activity Database

    Lolicato, F.; Akola, J.; Martinez-Seara, Hector; Vattulainen, I.

    2017-01-01

    Roč. 46, Suppl 1 (2017), S222 ISSN 0175-7571. [IUPAB congress /19./ and EBSA congress /11./. 16.07.2017-20.07.2017, Edinburgh] Institutional support: RVO:61388963 Keywords : nanoparticles * molecular dynamics simulations Subject RIV: BO - Biophysics

  20. Temporal scalability comparison of the H.264/SVC and distributed video codec

    DEFF Research Database (Denmark)

    Huang, Xin; Ukhanova, Ann; Belyaev, Evgeny

    2009-01-01

    The problem of the multimedia scalable video streaming is a current topic of interest. There exist many methods for scalable video coding. This paper is focused on the scalable extension of H.264/AVC (H.264/SVC) and distributed video coding (DVC). The paper presents an efficiency comparison of SV...

  1. Molecular dynamics simulations of the penetration lengths: application within the fluctuation theory for diffusion coefficients

    DEFF Research Database (Denmark)

    Galliero, Guillaume; Medvedev, Oleg; Shapiro, Alexander

    2005-01-01

    A 322 (2004) 151). In the current study, a fast molecular dynamics scheme has been developed to determine the values of the penetration lengths in Lennard-Jones binary systems. Results deduced from computations provide a new insight into the concept of penetration lengths. It is shown for four different...... fluctuation theory and molecular dynamics scheme exhibit consistent trends and average deviations from experimental data around 10-20%. (c) 2004 Elsevier B.V. All rights reserved....

  2. Comparative classical and 'ab initio' molecular dynamics study of molten and glassy germanium dioxide

    International Nuclear Information System (INIS)

    Hawlitzky, M; Horbach, J; Binder, K; Ispas, S; Krack, M

    2008-01-01

    A molecular dynamics (MD) study of the static and dynamic properties of molten and glassy germanium dioxide is presented. The interactions between the atoms are modeled by the classical pair potential proposed by Oeffner and Elliott (OE) (1998 Phys. Rev. B 58 14791). We compare our results to experiments and previous simulations. In addition, an 'ab initio' method, the so-called Car-Parrinello molecular dynamics (CPMD), is applied to check the accuracy of the structural properties, as obtained by the classical MD simulations with the OE potential. As in a similar study for SiO 2 , the structure predicted by CPMD is only slightly softer than that resulting from the classical MD. In contrast to earlier simulations, both the static structure and dynamic properties are in very good agreement with pertinent experimental data. MD simulations with the OE potential are also used to study the relaxation dynamics. As previously found for SiO 2 , for high temperatures the dynamics of molten GeO 2 is compatible with a description in terms of mode coupling theory

  3. Classical molecular dynamics simulation of electronically non-adiabatic processes.

    Science.gov (United States)

    Miller, William H; Cotton, Stephen J

    2016-12-22

    Both classical and quantum mechanics (as well as hybrids thereof, i.e., semiclassical approaches) find widespread use in simulating dynamical processes in molecular systems. For large chemical systems, however, which involve potential energy surfaces (PES) of general/arbitrary form, it is usually the case that only classical molecular dynamics (MD) approaches are feasible, and their use is thus ubiquitous nowadays, at least for chemical processes involving dynamics on a single PES (i.e., within a single Born-Oppenheimer electronic state). This paper reviews recent developments in an approach which extends standard classical MD methods to the treatment of electronically non-adiabatic processes, i.e., those that involve transitions between different electronic states. The approach treats nuclear and electronic degrees of freedom (DOF) equivalently (i.e., by classical mechanics, thereby retaining the simplicity of standard MD), and provides "quantization" of the electronic states through a symmetrical quasi-classical (SQC) windowing model. The approach is seen to be capable of treating extreme regimes of strong and weak coupling between the electronic states, as well as accurately describing coherence effects in the electronic DOF (including the de-coherence of such effects caused by coupling to the nuclear DOF). A survey of recent applications is presented to illustrate the performance of the approach. Also described is a newly developed variation on the original SQC model (found universally superior to the original) and a general extension of the SQC model to obtain the full electronic density matrix (at no additional cost/complexity).

  4. Molecular dynamics of nanodroplet impact: The effect of the projectile’s molecular mass on sputtering

    Energy Technology Data Exchange (ETDEWEB)

    Saiz, Fernan [Department of Chemistry, Imperial College of Science, Technology and Medicine, South Kensington, London, SW7 2A7 (United Kingdom); Gamero-Castaño, Manuel, E-mail: mgameroc@uci.edu [Department of Mechanical and Aerospace Engineering, University of California, Irvine, California, 92697 (United States)

    2016-06-15

    The impact of electrosprayed nanodroplets on ceramics at several km/s alters the atomic order of the target, causing sputtering, surface amorphization and cratering. The molecular mass of the projectile is known to have a strong effect on the impact phenomenology, and this article aims to rationalize this dependency using molecular dynamics. To achieve this goal, the article models the impact of four projectiles with molecular masses between 45 and 391 amu, and identical diameters and kinetic energies, 10 nm and 63 keV, striking a silicon target. In agreement with experiments, the simulations show that the number of sputtered atoms strongly increases with molecular mass. This is due to the increasing intensity of collision cascades with molecular mass: when the fixed kinetic energy of the projectile is distributed among fewer, more massive molecules, their collisions with the target produce knock-on atoms with higher energies, which in turn generate more energetic and larger numbers of secondary and tertiary knock-on atoms. The more energetic collision cascades intensify both knock-on sputtering and, upon thermalization, thermal sputtering. Besides enhancing sputtering, heavier molecules also increase the fraction of the projectile’s energy that is transferred to the target, as well as the fraction of this energy that is dissipated.

  5. Molecular dynamics of nanodroplet impact: The effect of the projectile’s molecular mass on sputtering

    International Nuclear Information System (INIS)

    Saiz, Fernan; Gamero-Castaño, Manuel

    2016-01-01

    The impact of electrosprayed nanodroplets on ceramics at several km/s alters the atomic order of the target, causing sputtering, surface amorphization and cratering. The molecular mass of the projectile is known to have a strong effect on the impact phenomenology, and this article aims to rationalize this dependency using molecular dynamics. To achieve this goal, the article models the impact of four projectiles with molecular masses between 45 and 391 amu, and identical diameters and kinetic energies, 10 nm and 63 keV, striking a silicon target. In agreement with experiments, the simulations show that the number of sputtered atoms strongly increases with molecular mass. This is due to the increasing intensity of collision cascades with molecular mass: when the fixed kinetic energy of the projectile is distributed among fewer, more massive molecules, their collisions with the target produce knock-on atoms with higher energies, which in turn generate more energetic and larger numbers of secondary and tertiary knock-on atoms. The more energetic collision cascades intensify both knock-on sputtering and, upon thermalization, thermal sputtering. Besides enhancing sputtering, heavier molecules also increase the fraction of the projectile’s energy that is transferred to the target, as well as the fraction of this energy that is dissipated.

  6. Scalable and near-optimal design space exploration for embedded systems

    CERN Document Server

    Kritikakou, Angeliki; Goutis, Costas

    2014-01-01

    This book describes scalable and near-optimal, processor-level design space exploration (DSE) methodologies.  The authors present design methodologies for data storage and processing in real-time, cost-sensitive data-dominated embedded systems.  Readers will be enabled to reduce time-to-market, while satisfying system requirements for performance, area, and energy consumption, thereby minimizing the overall cost of the final design.   • Describes design space exploration (DSE) methodologies for data storage and processing in embedded systems, which achieve near-optimal solutions with scalable exploration time; • Presents a set of principles and the processes which support the development of the proposed scalable and near-optimal methodologies; • Enables readers to apply scalable and near-optimal methodologies to the intra-signal in-place optimization step for both regular and irregular memory accesses.

  7. Software performance and scalability a quantitative approach

    CERN Document Server

    Liu, Henry H

    2009-01-01

    Praise from the Reviewers:"The practicality of the subject in a real-world situation distinguishes this book from othersavailable on the market."—Professor Behrouz Far, University of Calgary"This book could replace the computer organization texts now in use that every CS and CpEstudent must take. . . . It is much needed, well written, and thoughtful."—Professor Larry Bernstein, Stevens Institute of TechnologyA distinctive, educational text onsoftware performance and scalabilityThis is the first book to take a quantitative approach to the subject of software performance and scalability

  8. Nano-confined water in the interlayers of hydrocalumite: Reorientational dynamics probed by neutron spectroscopy and molecular dynamics computer simulations

    Science.gov (United States)

    Kalinichev, A. G.; Faraone, A.; Udovic, T.; Kolesnikov, A. I.; de Souza, N. R.; Reinholdt, M. X.; Kirkpatrick, R.

    2008-12-01

    Layered double hydroxides (LDHs, anionic clays) represent excellent model systems for detailed molecular- level studies of the structure, dynamics, and energetics of nano-confined water in mineral interlayers and nano-pores, because LDH interlayers can have a well-defined structures and contain H2O molecules and a wide variety of anions in structurally well-defined positions and coordinations. [Ca2Al(OH)6]Cl·2H2O, also known as hydrocalumite or Friedel's salt, has a well- ordered Ca,Al distribution in the hydroxide layer and a very high degree of H2O,Cl ordering in the interlayer. It is also one of the only LDH phase for which a single crystal structure refinement is available. Thus, it is currently the best model compound for understanding the structure and dynamical behavior of interlayer and surface species in other, less-ordered, LDHs. We investigated the structural and dynamic behavior of water in the interlayers of hydrocalumite using inelastic (INS) and quasielastic (QENS) neutron scattering and molecular dynamics computer simulations. The comperehensive neutron scattering studies were performed for one fully hydrated and one dehydrated sample of hydrocalumite using several complementary instruments (HFBS, DCS and FANS at NCNR; HRMECS and QENS at IPNS) at temperatures above and below the previously discovered order-disorder interlayer phase transition. Together the experimental and molecular modeling results capture the important details of the dynamics of nano-confined water and the effects of the orientational ordering of H2O molecules above and below the phase transition. They provide otherwise unobtainable experimental information about the transformation of H2O librational and diffusional modes across the order-disorder phase transition and significantly add to our current understanding of the structure and dynamics of water in LDH phases based on the earlier NMR, IR, X-ray, and calorimetric measurements. The approach can now be extended to probe the

  9. A comparative study of ibuprofen and ketoprofen glass-forming liquids by molecular dynamics simulations

    Science.gov (United States)

    Ottou Abe, M. T.; Correia, N. T.; Ndjaka, J. M. B.; Affouard, F.

    2015-10-01

    In this paper, structural and dynamical properties of ibuprofen and ketoprofen glass-forming liquids have been investigated by means of molecular dynamics simulations. Molecular mobility of both materials is analyzed with respect to the different inter-molecular linear/cyclic hydrogen bonding associations. For ibuprofen, the dominant organization is found to be composed of small hydrogen bonding aggregates corresponding to cyclic dimers through the carboxyl group. For ketoprofen, the propensity of cyclic dimers is significantly reduced by the formation of hydrogen bonds with the ketone oxygen of the molecule altering the hydrogen bond (HB) associating structures that can be formed and thus molecular dynamics. The issue of the presence/absence of the peculiar low frequency Debye-type process in dielectric relaxation spectroscopy (DRS) data in these materials is addressed. Results obtained from simulations confirm that the Debye process originates from the internal cis-trans conversion of the —COOH carboxyl group. It is shown that the specific intermolecular HB structures associated to a given profen control the main dynamical features of this conversion, in particular its separation from the α-process, which make it detectable or not from DRS. For ibuprofen, the possible role of the —CCCO torsion motion, more "local" than the —COOH motion since it is less influenced by the intermolecular HBs, is suggested in the microscopic origin of the quite intense secondary γ-relaxation process detected from DRS.

  10. The molecular dynamics simulation of ion-induced ripple growth

    International Nuclear Information System (INIS)

    Suele, P.; Heinig, K.-H.

    2009-01-01

    The wavelength-dependence of ion-sputtering induced growth of repetitive nanostructures, such as ripples has been studied by molecular dynamics (MD) simulations in Si. The early stage of the ion erosion driven development of ripples has been simulated on prepatterned Si stripes with a wavy surface. The time evolution of the height function and amplitude of the sinusoidal surface profile has been followed by simulated ion-sputtering. According to Bradley-Harper (BH) theory, we expect correlation between the wavelength of ripples and the stability of them. However, we find that in the small ripple wavelength (λ) regime BH theory fails to reproduce the results obtained by molecular dynamics. We find that at short wavelengths (λ 35 nm is stabilized in accordance with the available experimental results. According to the simulations, few hundreds of ion impacts in λ long and few nanometers wide Si ripples are sufficient for reaching saturation in surface growth for for λ>35 nm ripples. In another words, ripples in the long wavelength limit seems to be stable against ion-sputtering. A qualitative comparison of our simulation results with recent experimental data on nanopatterning under irradiation is attempted.

  11. Molecular dynamics simulations of ballistic He penetration into W fuzz

    NARCIS (Netherlands)

    Klaver, T. P. C.; Nordlund, K.; Morgan, T. W.; Westerhof, E.; Thijsse, B. J.; van de Sanden, M. C. M.

    2016-01-01

    Results are presented of large-scale Molecular Dynamics simulations of low-energy He bombardment of W nanorods, or so-called ‘fuzz’ structures. The goal of these simulations is to see if ballistic He penetration through W fuzz offers a more realistic scenario for how He moves through fuzz layers

  12. Molecular dynamics simulations of glycerol glass-forming liquid

    International Nuclear Information System (INIS)

    Blieck, J.; Affouard, F.; Bordat, P.; Lerbret, A.; Descamps, M.

    2005-01-01

    Structural and dynamical properties of liquid glycerol have been investigated by Molecular Dynamics simulations. An improved model based on a slight reparametrisation of the all-atoms AMBER force field used in [R. Chelli, P. Procacci, G. Cardini, R.G.D. Valle, S. Califano, Phys. Chem. Chem. Phys. 1 (1999) 871] is presented. The structure remains satisfactory, qualitatively similar to that obtained from the original model. This new model is also found to reproduce significantly better the diffusion coefficient and the correlations times as they can be deduced from neutron spin echo (NSE) experiments. Structural heterogeneities revealed as a pre-peak of the static structure factor S(Q) close to Q ∼ 0.6 A -1 are observed. Our results are also found compatible with predictions of the Mode Coupling Theory

  13. Computational exploration of single-protein mechanics by steered molecular dynamics

    Energy Technology Data Exchange (ETDEWEB)

    Sotomayor, Marcos [Department of Chemistry and Biochemistry, The Ohio State University, Columbus, Ohio (United States)

    2015-12-31

    Hair cell mechanotransduction happens in tens of microseconds, involves forces of a few picoNewtons, and is mediated by nanometer-scale molecular conformational changes. As proteins involved in this process become identified and their high resolution structures become available, multiple tools are being used to explore their “single-molecule responses” to force. Optical tweezers and atomic force microscopy offer exquisite force and extension resolution, but cannot reach the high loading rates expected for high frequency auditory stimuli. Molecular dynamics (MD) simulations can reach these fast time scales, and also provide a unique view of the molecular events underlying protein mechanics, but its predictions must be experimentally verified. Thus a combination of simulations and experiments might be appropriate to study the molecular mechanics of hearing. Here I review the basics of MD simulations and the different methods used to apply force and study protein mechanics in silico. Simulations of tip link proteins are used to illustrate the advantages and limitations of this method.

  14. Numerical methodologies for investigation of moderate-velocity flow using a hybrid computational fluid dynamics - molecular dynamics simulation approach

    International Nuclear Information System (INIS)

    Ko, Soon Heum; Kim, Na Yong; Nikitopoulos, Dimitris E.; Moldovan, Dorel; Jha, Shantenu

    2014-01-01

    Numerical approaches are presented to minimize the statistical errors inherently present due to finite sampling and the presence of thermal fluctuations in the molecular region of a hybrid computational fluid dynamics (CFD) - molecular dynamics (MD) flow solution. Near the fluid-solid interface the hybrid CFD-MD simulation approach provides a more accurate solution, especially in the presence of significant molecular-level phenomena, than the traditional continuum-based simulation techniques. It also involves less computational cost than the pure particle-based MD. Despite these advantages the hybrid CFD-MD methodology has been applied mostly in flow studies at high velocities, mainly because of the higher statistical errors associated with low velocities. As an alternative to the costly increase of the size of the MD region to decrease statistical errors, we investigate a few numerical approaches that reduce sampling noise of the solution at moderate-velocities. These methods are based on sampling of multiple simulation replicas and linear regression of multiple spatial/temporal samples. We discuss the advantages and disadvantages of each technique in the perspective of solution accuracy and computational cost.

  15. Quantitative Analysis of the Molecular Dynamics of P3HT:PCBM Bulk Heterojunction.

    Science.gov (United States)

    Guilbert, Anne A Y; Zbiri, Mohamed; Dunbar, Alan D F; Nelson, Jenny

    2017-09-28

    The optoelectronic properties of blends of conjugated polymers and small molecules are likely to be affected by the molecular dynamics of the active layer components. We study the dynamics of regioregular poly(3-hexylthiophene) (P3HT):phenyl-C61-butyric acid methyl ester (PCBM) blends using molecular dynamics (MD) simulation on time scales up to 50 ns and in a temperature range of 250-360 K. First, we compare the MD results with quasi-elastic neutron-scattering (QENS) measurements. Experiment and simulation give evidence of the vitrification of P3HT upon blending and the plasticization of PCBM by P3HT. Second, we reconstruct the QENS signal based on the independent simulations of the three phases constituting the complex microstructure of such blends. Finally, we found that P3HT chains tend to wrap around PCBM molecules in the amorphous mixture of P3HT and PCBM; this molecular interaction between P3HT and PCBM is likely to be responsible for the observed frustration of P3HT, the plasticization of PCBM, and the partial miscibility of P3HT and PCBM.

  16. DNA-programmed dynamic assembly of quantum dots for molecular computation.

    Science.gov (United States)

    He, Xuewen; Li, Zhi; Chen, Muzi; Ma, Nan

    2014-12-22

    Despite the widespread use of quantum dots (QDs) for biosensing and bioimaging, QD-based bio-interfaceable and reconfigurable molecular computing systems have not yet been realized. DNA-programmed dynamic assembly of multi-color QDs is presented for the construction of a new class of fluorescence resonance energy transfer (FRET)-based QD computing systems. A complete set of seven elementary logic gates (OR, AND, NOR, NAND, INH, XOR, XNOR) are realized using a series of binary and ternary QD complexes operated by strand displacement reactions. The integration of different logic gates into a half-adder circuit for molecular computation is also demonstrated. This strategy is quite versatile and straightforward for logical operations and would pave the way for QD-biocomputing-based intelligent molecular diagnostics. © 2014 WILEY-VCH Verlag GmbH & Co. KGaA, Weinheim.

  17. Molecular dynamics simulations of the dielectric properties of fructose aqueous solutions

    International Nuclear Information System (INIS)

    Sonoda, Milton T; Dolores Elola, M; Skaf, Munir S

    2016-01-01

    The static dielectric permittivity and dielectric relaxation properties of fructose aqueous solutions of different concentrations ranging from 1.0 to 4.0 mol l −1 are investigated by means of molecular dynamics simulations. The contributions from intra- and interspecies molecular correlations were computed individually for both the static and frequency-dependent dielectric properties, and the results were compared with the available experimental data. Simulation results in the time- and frequency-domains were analyzed and indicate that the presence of fructose has little effect on the position of the fast, high-frequency (>500 cm −1 ) components of the dielectric response spectrum. The low-frequency (<0.1 cm −1 ) components, however, are markedly influenced by sugar concentration. Our analysis indicates that fructose–fructose and fructose–water interactions strongly affect the rotational-diffusion regime of molecular motions in the solutions. Increasing fructose concentration not only enhances sugar–sugar and sugar-water low frequency contributions to the dielectric loss spectrum but also slows down the reorientational dynamics of water molecules. These results are consistent with previous computer simulations carried out for other disaccharide aqueous solutions. (paper)

  18. Revealing Atomic-Level Mechanisms of Protein Allostery with Molecular Dynamics Simulations.

    Directory of Open Access Journals (Sweden)

    Samuel Hertig

    2016-06-01

    Full Text Available Molecular dynamics (MD simulations have become a powerful and popular method for the study of protein allostery, the widespread phenomenon in which a stimulus at one site on a protein influences the properties of another site on the protein. By capturing the motions of a protein's constituent atoms, simulations can enable the discovery of allosteric binding sites and the determination of the mechanistic basis for allostery. These results can provide a foundation for applications including rational drug design and protein engineering. Here, we provide an introduction to the investigation of protein allostery using molecular dynamics simulation. We emphasize the importance of designing simulations that include appropriate perturbations to the molecular system, such as the addition or removal of ligands or the application of mechanical force. We also demonstrate how the bidirectional nature of allostery-the fact that the two sites involved influence one another in a symmetrical manner-can facilitate such investigations. Through a series of case studies, we illustrate how these concepts have been used to reveal the structural basis for allostery in several proteins and protein complexes of biological and pharmaceutical interest.

  19. A novel energy conversion based method for velocity correction in molecular dynamics simulations

    Energy Technology Data Exchange (ETDEWEB)

    Jin, Hanhui [School of Aeronautics and Astronautics, Zhejiang University, Hangzhou 310027 (China); Collaborative Innovation Center of Advanced Aero-Engine, Hangzhou 310027 (China); Liu, Ningning [School of Aeronautics and Astronautics, Zhejiang University, Hangzhou 310027 (China); Ku, Xiaoke, E-mail: xiaokeku@zju.edu.cn [School of Aeronautics and Astronautics, Zhejiang University, Hangzhou 310027 (China); Fan, Jianren [State Key Laboratory of Clean Energy Utilization, Zhejiang University, Hangzhou 310027 (China)

    2017-05-01

    Molecular dynamics (MD) simulation has become an important tool for studying micro- or nano-scale dynamics and the statistical properties of fluids and solids. In MD simulations, there are mainly two approaches: equilibrium and non-equilibrium molecular dynamics (EMD and NEMD). In this paper, a new energy conversion based correction (ECBC) method for MD is developed. Unlike the traditional systematic correction based on macroscopic parameters, the ECBC method is developed strictly based on the physical interaction processes between the pair of molecules or atoms. The developed ECBC method can apply to EMD and NEMD directly. While using MD with this method, the difference between the EMD and NEMD is eliminated, and no macroscopic parameters such as external imposed potentials or coefficients are needed. With this method, many limits of using MD are lifted. The application scope of MD is greatly extended.

  20. A novel energy conversion based method for velocity correction in molecular dynamics simulations

    International Nuclear Information System (INIS)

    Jin, Hanhui; Liu, Ningning; Ku, Xiaoke; Fan, Jianren

    2017-01-01

    Molecular dynamics (MD) simulation has become an important tool for studying micro- or nano-scale dynamics and the statistical properties of fluids and solids. In MD simulations, there are mainly two approaches: equilibrium and non-equilibrium molecular dynamics (EMD and NEMD). In this paper, a new energy conversion based correction (ECBC) method for MD is developed. Unlike the traditional systematic correction based on macroscopic parameters, the ECBC method is developed strictly based on the physical interaction processes between the pair of molecules or atoms. The developed ECBC method can apply to EMD and NEMD directly. While using MD with this method, the difference between the EMD and NEMD is eliminated, and no macroscopic parameters such as external imposed potentials or coefficients are needed. With this method, many limits of using MD are lifted. The application scope of MD is greatly extended.