首页 | 本学科首页   官方微博 | 高级检索  
相似文献
 共查询到20条相似文献,搜索用时 31 毫秒
1.
2.
We document our Fortran 77 code for multicanonical simulations of 4D U(1) lattice gauge theory in the neighborhood of its phase transition. This includes programs and routines for canonical simulations using biased Metropolis heatbath updating and overrelaxation, determination of multicanonical weights via a Wang-Landau recursion, and multicanonical simulations with fixed weights supplemented by overrelaxation sweeps. Measurements are performed for the action, Polyakov loops and some of their structure factors. Many features of the code transcend the particular application and are expected to be useful for other lattice gauge theory models as well as for systems in statistical physics.

Program summary

Program title: STMC_U1MUCACatalogue identifier: AEET_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEET_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 18 376No. of bytes in distributed program, including test data, etc.: 205 183Distribution format: tar.gzProgramming language: Fortran 77Computer: Any capable of compiling and executing Fortran codeOperating system: Any capable of compiling and executing Fortran codeClassification: 11.5Nature of problem: Efficient Markov chain Monte Carlo simulation of U(1) lattice gauge theory close to its phase transition. Measurements and analysis of the action per plaquette, the specific heat, Polyakov loops and their structure factors.Solution method: Multicanonical simulations with an initial Wang-Landau recursion to determine suitable weight factors. Reweighting to physical values using logarithmic coding and calculating jackknife error bars.Running time: The prepared tests runs took up to 74 minutes to execute on a 2 GHz PC.  相似文献   

3.
A computational approach is presented for efficient solution of two-dimensional few-body problems, such as quantum dots or excitonic complexes, using the stochastic variational method. The computer program can be used to calculate the energies and wave functions of various two-dimensional systems.

Program summary

Program title: svm-2dCatalogue identifier: AEBE_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEBE_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 5091No. of bytes in distributed program, including test data, etc.: 130 963Distribution format: tar.gzProgramming language: Fortran 90Computer: The program should work on any system with a Fortran 90 compilerOperating system: The program should work on any system with a Fortran 90 compilerClassification: 7.3Nature of problem: Variational calculation of energies and wave functions using Correlated Gaussian basis.Solution method: Two-dimensional few-electron problems are solved by the variational method. The ground state wave function is expanded into Correlated Gaussian basis functions and the parameters of the basis states are optimized by a stochastic selection procedure. Accurate results can be obtained for 2-6 electron systems.Running time: A couple of hours for a typical system.  相似文献   

4.
We present a driver program for performing replica-exchange molecular dynamics simulations with the Tinker package. Parallelization is based on the Message Passing Interface, with every replica assigned to a separate process. The algorithm is not communication intensive, which makes the program suitable for running even on loosely coupled cluster systems. Particular attention is paid to the practical aspects of analyzing the program output.

Program summary

Program title: TiReXCatalogue identifier: AEEK_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEEK_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 43 385No. of bytes in distributed program, including test data, etc.: 502 262Distribution format: tar.gzProgramming language: Fortran 90/95Computer: Most UNIX machinesOperating system: LinuxHas the code been vectorized or parallelized?: parallelized with MPIClassification: 16.13External routines: TINKER version 4.2 or 5.0, built as a libraryNature of problem: Replica-exchange molecular dynamics.Solution method: Each replica is assigned to a separate process; temperatures are swapped between replicas at regular time intervals.Running time: The sample run may take up to a few minutes.  相似文献   

5.
Fortran 77 code is presented for a hybrid method of the Metropolis Monte Carlo (MMC) and Reverse Monte Carlo (RMC) for the simulation of amorphous silicon and carbon structures. In additional to the usual constraints of the pair correlation functions and average coordination, the code also incorporates an optional energy constraint. This energy constraint is in the form of either the Environment Dependent Interatomic Potential (applicable to silicon and carbon) and the original and modified Stillinger-Weber potentials (applicable to silicon). The code also allows porous systems to be modeled via a constraint on porosity and internal surface area using a novel restriction on the available simulation volume.

Program summary

Program title: HRMC version 1.0Catalogue identifier: AEAO_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEAO_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 200 894No. of bytes in distributed program, including test data, etc.: 907 557Distribution format: tar.gzProgramming language: FORTRAN 77Computer: Any computer capable of running executables produced by the g77 Fortran compilerOperating system: Unix, WindowsRAM: Depends on the type of empirical potential use, number of atoms and which constraints are employedClassification: 7.7Nature of problem: Atomic modeling using empirical potentials and experimental dataSolution method: Monte CarloAdditional comments: The code is not standard FORTRAN 77 but includes some additional features and therefore generates errors when compiled using the Nag95 compiler. It does compile successfully with the GNU g77 compiler (http://www.gnu.org/software/fortran/fortran.html).Running time: Depends on the type of empirical potential use, number of atoms and which constraints are employed. The test included in the distribution took 37 minutes on a DEC Alpha PC.  相似文献   

6.
Nowadays the state of the art Density Functional Theory (DFT) codes are based on local (LDA) or semilocal (GGA) energy functionals. Recently the theory of a truly nonlocal energy functional has been developed. It has been used mostly as a post-DFT calculation approach, i.e. by applying the functional to the charge density calculated using any standard DFT code, thus obtaining a new improved value for the total energy of the system. Nonlocal calculation is computationally quite expensive and scales as N2 where N is the number of points in which the density is defined, and a massively parallel calculation is welcome for a wider applicability of the new approach. In this article we present a code which accomplishes this goal.

Program summary

Program title: JuNoLoCatalogue identifier: AEFM_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEFM_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 176 980No. of bytes in distributed program, including test data, etc.: 2 126 072Distribution format: tar.gzProgramming language: Fortran 90Computer: any architecture with a Fortran 90 compilerOperating system: Linux, AIXHas the code been vectorised or parallelized?: Yes, from 1 to 65536 processors may be used.RAM: depends strongly on the problem's size.Classification: 7.3External routines:• FFTW (http://www.tw.org/)• MPI (http://www.mcs.anl.gov/research/projects/mpich2/ or http://www.lam-mpi.org/)Nature of problem: Obtaining the value of the nonlocal vdW-DF energy based on the charge density distribution obtained from some Density Functional Theory code.Solution method: Numerical calculation of the double sum is implemented in a parallel F90 code. Calculation of this sum yields the required nonlocal vdW-DF energy.Unusual features: Binds to virtually any DFT program.Additional comments: Excellent parallelization features.Running time: Depends strongly on the size of the problem and the number of CPUs used.  相似文献   

7.
A program that uses the time-dependent wavepacket method to study the motion of structureless particles in a force field of quasi-cylindrical symmetry is presented here. The program utilises cylindrical polar coordinates to express the wavepacket, which is subsequently propagated using a Chebyshev expansion of the Schrödinger propagator. Time-dependent exit flux as well as energy-dependent S matrix elements can be obtained for all states of the particle (describing its angular momentum component along the nanotube axis and the excitation of the radial degree of freedom in the cylinder). The program has been used to study the motion of an H atom across a carbon nanotube.

Program summary

Program title: CYLWAVECatalogue identifier: AECL_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AECL_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 3673No. of bytes in distributed program, including test data, etc.: 35 237Distribution format: tar.gzProgramming language: Fortran 77Computer: RISC workstationsOperating system: UNIXRAM: 120 MBytesClassification: 16.7, 16.10External routines: SUNSOFT performance library (not essential) TFFT2D.F (Temperton Fast Fourier Transform), BESSJ.F (from Numerical Recipes, for the calculation of Bessel functions) (included in the distribution file).Nature of problem: Time evolution of the state of a structureless particle in a quasicylindrical potential.Solution method: Time dependent wavepacket propagation.Running time: 50000 secs. The test run supplied with the distribution takes about 10 minutes to complete.  相似文献   

8.
When one deals with data drawn from continuous variables, a histogram is often inadequate to display their probability density. It deals inefficiently with statistical noise, and binsizes are free parameters. In contrast to that, the empirical cumulative distribution function (obtained after sorting the data) is parameter free. But it is a step function, so that its differentiation does not give a smooth probability density. Based on Fourier series expansion and Kolmogorov tests, we introduce a simple method, which overcomes this problem. Error bars on the estimated probability density are calculated using a jackknife method. We give several examples and provide computer code reproducing them. You may want to look at the corresponding figures 4 to 9 first.

Program summary

Program title: cdf_to_pdCatalogue identifier: AEBC_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEBC_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 2758No. of bytes in distributed program, including test data, etc.: 18 594Distribution format: tar.gzProgramming language: Fortran 77Computer: Any capable of compiling and executing Fortran codeOperating system: Any capable of compiling and executing Fortran codeClassification: 4.14, 9Nature of problem: When one deals with data drawn from continuous variables, a histogram is often inadequate to display the probability density. It deals inefficiently with statistical noise, and binsizes are free parameters. In contrast to that, the empirical cumulative distribution function (obtained after sorting the data) is parameter free. But it is a step function, so that its differentiation does not give a smooth probability density.Solution method: Based on Fourier series expansion and Kolmogorov tests, we introduce a simple method, which overcomes this problem. Error bars on the estimated probability density are calculated using a jackknife method. Several examples are included in the distribution file.Running time: The test runs provided take only a few seconds to execute.  相似文献   

9.
We present a computer package designed to generate and test norm-conserving pseudo-potentials within Density Functional Theory. The generated pseudo-potentials can be either non-relativistic, scalar relativistic or fully relativistic and can explicitly include semi-core states. A wide range of exchange-correlation functionals is included.

Program summary

Program title: Atomic Pseudo-potentials Engine (APE)Catalogue identifier: AEAC_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEAC_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 88 287No. of bytes in distributed program, including test data, etc.: 649 959Distribution format: tar.gzProgramming language: Fortran 90, CComputer: any computer architecture, running any flavor of UNIXOperating system: GNU/LinuxRAM: <5 MbClassification: 7.3External routines: GSL (http://www.gnu.org/software/gsl/)Nature of problem: Determination of atomic eigenvalues and wave-functions using relativistic and nonrelativistic Density-Functional Theory. Construction of pseudo-potentials for use in ab-initio simulations.Solution method: Grid-based integration of the Kohn-Sham equations.Restrictions: Relativistic spin-polarized calculations are not possible. The set of exchange-correlation functionals implemented in the code does not include orbital-dependent functionals.Unusual features: The program creates pseudo-potential files suitable for the most widely used ab-initio packages and, besides the standard non-relativistic Hamann and Troullier-Martins potentials, it can generate pseudo-potentials using the relativistic and semi-core extensions to the Troullier-Martins scheme. APE also has a very sophisticated and user-friendly input system.Running time: The example given in this paper (Si) takes 10 s to run on a Pentium IV machine clocked at 2 GHz.  相似文献   

10.
We describe a program for computing the abundances of light elements produced during Big Bang Nucleosynthesis which is publicly available at http://parthenope.na.infn.it/. Starting from nuclear statistical equilibrium conditions the program solves the set of coupled ordinary differential equations, follows the departure from chemical equilibrium of nuclear species, and determines their asymptotic abundances as function of several input cosmological parameters as the baryon density, the number of effective neutrino, the value of cosmological constant and the neutrino chemical potential. The program requires commercial NAG library routines.

Program summary

Program title: PArthENoPECatalogue identifier: AEAV_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEAV_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 10 033No. of bytes in distributed program, including test data, etc.: 46 002Distribution format: tar.gzProgramming language: Fortran 77Computer: PC-compatible running Fortran on Unix, MS Windows or LinuxOperating system: Windows 2000, Windows XP, LinuxClassification: 1.2, 1.9, 17.8External routines: NAG LibrariesNature of problem: Computation of yields of light elements synthesized in the primordial universe.Solution method: BDF method for the integration of the ODEs, implemented in a NAG routine.Running time: 90 sec with default parameters on a Dual Xeon Processor 2.4 GHz with 2 GB RAM.  相似文献   

11.
Exact expressions are presented for efficient computation of the weights in Gauss-Legendre and Chebyshev quadratures for selected singular integrands. The singularities may be of Cauchy type, logarithmic type or algebraic-logarithmic end-point branching points. We provide Fortran 90 routines for computing the weights for both the Gauss-Legendre and the Chebyshev (Fejér-1) meshes whose size can be set by the user.

New program summary

Program title: SINGQUADCatalogue identifier: AEBR_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEBR_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 4128No. of bytes in distributed program, including test data, etc.: 25 815Distribution format: tar.gzProgramming language: Fortran 90Computer: Any with a Fortran 90 compilerOperating system: Linux, Windows, MacRAM: Depending on the complexity of the problemClassification: 4.11Nature of problem: Program provides Gauss-Legendre and Chebyshev (Fejér-1) weights for various singular integrands.Solution method: The weights are obtained from the condition that the quadrature of order N must be exact for a polynomial of degree?(N−1). The weights are expressed as moments of the singular kernels associated with Legendre or Chebyshev polynomials. These moments are obtained in analytic form amenable for computation.Additional comments: If the NAGWare f95 compiler is used, the option, “-kind = byte”, must be included in the compile command lines of the Makefile.Running time: The test run supplied with the distribution takes a couple of seconds to execute.  相似文献   

12.
A library for reading and writing data in the SUSY Les Houches Accord 2 format is presented. The implementation is in native Fortran 77. The data are contained in a single array conveniently indexed by preprocessor statements.

Program summary

Program title: SLHA2LibCatalogue identifier: AEDY_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEDY_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 7550No. of bytes in distributed program, including test data, etc.: 160 123Distribution format: tar.gzProgramming language: FortranComputer: For the build process, a Fortran 77 compiler in a Unixish environment (make, shell) are requiredOperating system: Linux, Mac OS, Windows (Cygwin), Tru64 UnixRAM: The SLHA Record is currently 88 944 bytes longClassification: 4.14, 11.6Nature of problem: Exchange of SUSY parameters and decay information in an ASCII file format.Solution method: The SLHA2Lib provides routines for reading and writing files in the SUSY Les Houches Accord 2 format, a common interchange format for SUSY parameters and decay data.Restrictions: The fixed-sized array that holds the SLHA2 data necessarily limits the amount of decay data that can be stored. This limit can be enlarged by editing and re-running the SLHA2.m program.Unusual features: Data are transported in a single “double complex” array in Fortran, indexed through preprocessor macros. This is about the simplest conceivable container and needs neither dynamic memory allocation nor Fortran extension like structures.Running time: Both reading and writing a SLHA file are typically in the range of a few milliseconds.  相似文献   

13.
An interactive Java applet for real-time simulation and visualization of the transmittance properties of multiple interference dielectric filters is presented. The most commonly used interference filters as well as the state-of-the-art ones are embedded in this platform-independent applet which can serve research and education purposes. The Transmittance applet can be freely downloaded from the site http://cpc.cs.qub.ac.uk.

Program summary

Program title: TransmittanceCatalogue identifier: AEBQ_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEBQ_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 5778No. of bytes in distributed program, including test data, etc.: 90 474Distribution format: tar.gzProgramming language: JavaComputer: Developed on PC-Pentium platformOperating system: Any Java-enabled OS. Applet was tested on Windows ME, XP, Sun Solaris, Mac OSRAM: VariableClassification: 18Nature of problem: Sophisticated wavelength selective multiple interference filters can include some tens or even hundreds of dielectric layers. The spectral response of such a stack is not obvious. On the other hand, there is a strong demand from application designers and students to get a quick insight into the properties of a given filter.Solution method: A Java applet was developed for the computation and the visualization of the transmittance of multilayer interference filters. It is simple to use and the embedded filter library can serve educational purposes. Also, its ability to handle complex structures will be appreciated as a useful research and development tool.Running time: Real-time simulations  相似文献   

14.
15.
This paper discusses the concept, application, and usefulness of software design patterns for scientific programming in Fortran 90/95. An example from the discipline of object-oriented design patterns, that of a game based on navigation through a maze, is used to describe how some important patterns can be implemented in Fortran 90/95 and how the progressive introduction of design patterns can usefully restructure Fortran software as it evolves. This example is complemented by a discussion of how design patterns have been used in a real-life simulation of Particle-in-Cell plasma physics. The following patterns are mentioned in this paper: Factory, Strategy, Template, Abstract Factory and Facade.

Program summary

Program title: mazev1, mazev2, mazev3Catalogue identifier: AEAI_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEAI_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 1958No. of bytes in distributed program, including test data, etc.: 17 100Distribution format: tar.gzProgramming language: Fortran 95Computer: PC/MacOperating system: Unix/Linux/Mac (FreeBSD)/Windows (Cygwin)RAM: These are interactive programs with small (KB) memory requirementsClassification: 6.5, 20Nature of problem: A sequence of programs which demonstrate the use of object oriented design patterns for the restructuring of Fortran 90/95 software. The programs implement a simple maze game similar to that described in [1].Solution method: Restructuring uses versions of the Template, Strategy and Factory design patterns.Running time: Interactive.References:
[1] 
E. Gamma, R. Helm, R. Johnson, J. Vlissides, Design Patterns: Elements of Reusable Object Oriented Software, Addison-Wesley, 1995, ISBN 0201633612.
  相似文献   

16.
The routine Milne provides accurate numerical values for the classical Milne's problem of neutron transport for the planar one speed and isotropic scattering case. The solution is based on the Case eigen-function formalism. The relevant X functions are evaluated accurately by the Double Exponential quadrature. The calculated quantities are the extrapolation distance and the scalar and the angular fluxes. Also, the H function needed in astrophysical calculations is evaluated as a byproduct.

Program summary

Program title: MilneCatalogue identifier: AEGS_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEGS_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 701No. of bytes in distributed program, including test data, etc.: 6845Distribution format: tar.gzProgramming language: Fortran 77Computer: PC under Linux or WindowsOperating system: Ubuntu 8.04 (Kernel version 2.6.24-16-generic), Windows-XPClassification: 4.11, 21.1, 21.2Nature of problem: The X functions are integral expressions. The convergence of these regular and Cauchy Principal Value integrals are impaired by the singularities of the integrand in the complex plane. The DE quadrature scheme tackles these singularities in a robust manner compared to the standard Gauss quadrature.Running time: The test included in the distribution takes a few seconds to run.  相似文献   

17.
We present a Fortran program to compute the distribution of dipole moments of free particles for use in analyzing molecular beams experiments that measure moments by deflection in an inhomogeneous field. The theory is the same for magnetic and electric dipole moments, and is based on a thermal ensemble of classical particles that are free to rotate and that have moment vectors aligned along a principal axis of rotation. The theory has two parameters, the ratio of the magnetic (or electric) dipole energy to the thermal energy, and the ratio of moments of inertia of the rotor.

Program summary

Program title:AdiabaticRotorCatalogue identifier:ADZO_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/ADZO_v1_0.htmlProgram obtainable from:CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions:Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.:479No. of bytes in distributed program, including test data, etc.:4853Distribution format:tar.gzProgramming language:Fortran 90Computer:Pentium-IV, Macintosh Power PC G4Operating system:Linux, Mac OS XRAM:600 KbytesWord size:64 bitsClassification:2.3Nature of problem:The system considered is a thermal ensemble of rotors having a magnetic or electric moment aligned along one of the principal axes. The ensemble is placed in an external field which is turned on adiabatically. The problem is to find the distribution of moments in the presence of the external field.Solution method:There are three adiabatic invariants. The only nontrivial one is the action associated with the polar angle of the rotor axis with respect to external field. It is found by Newton's method.Running time:3 min on a 3 GHz Pentium IV processor.  相似文献   

18.
The three-dimensional Mercedes-Benz model was recently introduced to account for the structural and thermodynamic properties of water. It treats water molecules as point-like particles with four dangling bonds in tetrahedral coordination, representing H-bonds of water. Its conceptual simplicity renders the model attractive in studies where complex behaviors emerge from H-bond interactions in water, e.g., the hydrophobic effect. A molecular dynamics (MD) implementation of the model is non-trivial and we outline here the mathematical framework of its force-field. Useful routines written in modern Fortran are also provided. This open source code is free and can easily be modified to account for different physical context. The provided code allows both serial and MPI-parallelized execution.Program summaryProgram title: CASHEW (Coarse Approach Simulator for Hydrogen-bonding Effects in Water)Catalogue identifier: AEKM_v1_0Program summary URL: http://cpc.cs.qub.ac.uk/summaries/AEKM_v1_0.htmlProgram obtainable from: CPC Program Library, Queen?s University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 20 501No. of bytes in distributed program, including test data, etc.: 551 044Distribution format: tar.gzProgramming language: Fortran 90Computer: Program has been tested on desktop workstations and a Cray XT4/XT5 supercomputer.Operating system: Linux, Unix, OS XHas the code been vectorized or parallelized?: The code has been parallelized using MPI.RAM: Depends on size of system, about 5 MB for 1500 molecules.Classification: 7.7External routines: A random number generator, Mersenne Twister (http://www.math.sci.hiroshima-u.ac.jp/m-mat/MT/VERSIONS/FORTRAN/mt95.f90), is used. A copy of the code is included in the distribution.Nature of problem: Molecular dynamics simulation of a new geometric water model.Solution method: New force-field for water molecules, velocity–Verlet integration, representation of molecules as rigid particles with rotations described using quaternion algebra.Restrictions: Memory and cpu time limit the size of simulations.Additional comments: Software web site: https://gitorious.org/cashew/.Running time: Depends on the size of system. The sample tests provided only take a few seconds.  相似文献   

19.
Given a space with a metric tensor defined on it, it is easy to write down the system of geodesic equations on it by using the formula for the Christoffel symbols in terms of the metric coefficients. In this paper the inverse problem, of reconstructing the space from the geodesic equations is addressed. A procedure is developed for obtaining the metric tensor explicitly from the Christoffel symbols. The procedure is extended for determining if a second order quadratically semi-linear system can be expressed as a system of geodesic equations, provided it has terms only quadratic in the first derivative apart from the second derivative term. A computer code has been developed for dealing with large systems of geodesic equations.

Program summary

Program title: geodesicCOMMENTED.nbCatalogue identifier: AEBA_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEBA_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 373No. of bytes in distributed program, including test data, etc.: 3641Distribution format: tar.gzProgramming language: MATHEMATICAComputer: Computers that run MATHEMATICAOperating system: MATHEMATICA runs under Linux and windowsRAM: Minimum of 512 kbytesClassification: 1.5Nature of problem: The code we have developed calculates the space when the geodesic equations are given.Solution method: The code gives the user the option of selecting a subset of the metric tensor required for constructing the Christoffel symbols. This system is over-determined hence the results are not unique.Running time: Dependent on the RAM available and complexity of the metric tensor.  相似文献   

20.
We describe the Monte Carlo event generator for black hole production and decay in proton-proton collisions - QBH version 1.02. The generator implements a model for quantum black hole production and decay based on the conservation of local gauge symmetries and democratic decays. The code in written entirely in C++ and interfaces to the PYTHIA 8 Monte Carlo code for fragmentation and decays.

Program summary

Program title: QBHCatalogue identifier: AEGU_v1_0Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEGU_v1_0.htmlProgram obtainable from: CPC Program Library, Queen's University, Belfast, N. IrelandLicensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.htmlNo. of lines in distributed program, including test data, etc.: 10 048No. of bytes in distributed program, including test data, etc.: 118 420Distribution format: tar.gzProgramming language: C++Computer: x86Operating system: Scientific Linux, Mac OS XRAM: 1 GBClassification: 11.6External routines: PYTHIA 8130 (http://home.thep.lu.se/~torbjorn/pythiaaux/present.html) and LHAPDF (http://projects.hepforge.org/lhapdf/)Nature of problem: Simulate black hole production and decay in proton-proton collision.Solution method: Monte Carlo simulation using importance sampling.Running time: Eight events per second.  相似文献   

设为首页 | 免责声明 | 关于勤云 | 加入收藏

Copyright©北京勤云科技发展有限公司  京ICP备09084417号