Folding@home
This article's introduction section may not adequately summarize its contents. To comply with Wikipedia's lead section guidelines, please consider expanding the lead to provide an accessible overview of the article's key points. (September 2009) |
File:Abeta-PS3.png The PlayStation 3 Folding@home client displays a 3D model of the protein being simulated | |
Original author(s) | Vijay Pande |
---|---|
Developer(s) | Stanford University / Pande Group |
Initial release | 2000-10-01 |
Stable release | Windows: 6.23 (Uniprocessor) 6.23 (GPU) Mac OS X: 6.24.1 (PPC-Uniprocessor) 6.29 (x86-SMP) Linux: 6.02 (Uniprocessor) 6.29 (x64-SMP) PlayStation 3: 1.41 [1] / January 21, 2010 (6.29) |
Preview release | 6.29 beta (Windows SMP) / January 21, 2010 |
Platform | Cross-platform |
Available in | English |
Type | Distributed computing |
License | Proprietary [1] |
Website | folding.stanford.edu |
Folding@home (sometimes abbreviated as FAH or F@h) is a distributed computing (DC) project designed to perform computationally intensive simulations of protein folding and other molecular dynamics (MD), and to improve on the methods available to do so. It was launched on October 1, 2000, and is currently managed by the Pande Group, within Stanford University's chemistry department, under the supervision of Professor Vijay Pande.
Folding@home is the most powerful distributed computing cluster in the world, according to Guinness,[2] and one of the world's largest distributed computing projects.[3] The goal of the project is "to understand protein folding, misfolding, and related diseases."[4]
Purpose
Accurate simulations of protein folding and misfolding enable the scientific community to better understand the development of many diseases, including sickle-cell disease (drepanocytosis), Alzheimer's disease, Parkinson's disease, mad cow disease, cancer, Huntington's disease, cystic fibrosis, osteogenesis imperfecta, alpha 1-antitrypsin deficiency, and other aggregation-related diseases.[5] More fundamentally, understanding the process of protein folding — how biological molecules assemble themselves into a functional state — is one of the outstanding problems of molecular biology. So far, the Folding@home project has successfully simulated folding in the 5-10 microsecond range — which is a far longer simulation than it was previously thought possible to model. The Pande Group goal is to refine and improve the MD and Folding@home DC methods to the level where it will become an essential tool for the MD research.[6] For that goal they collaborate with various scientific institutions.[7] As of January 13, 2010, seventy-two scientific research papers have been published using the project's work.[8] A University of Illinois at Urbana-Champaign report dated October 22, 2002 states that Folding@home distributed simulations of protein folding are demonstrably accurate.[9]
Function
Folding@home does not rely on powerful supercomputers for its data processing; instead, the primary contributors to the Folding@home project are many hundreds of thousands of personal computer users who have installed a client program. The client runs in the background, utilizing otherwise unused CPU power. The older, no longer used version of Folding@home for the CPU could be run as a screen saver, only folding while the user is away. In most modern personal computers, the CPU is rarely used to its full capacity at all times; the Folding@home client takes advantage of this unused processing power.
The Folding@home client periodically connects to a server to retrieve "work units", which are packets of data upon which to perform calculations. Each completed work unit is then sent back to the server. As data integrity is a major concern for all distributed computing projects, all work units are validated through the use of a 2048 bit digital signature.
Contributors to Folding@home may have user names used to keep track of their contributions. Each user may be running the client on one or more CPUs; for example, a user with two computers could run the client on both of them. Users may also contribute under one or more team names; many different users may join together to form a team. Contributors are assigned a score indicating the number and difficulty of completed work units. Rankings and other statistics are posted to the Folding@home website.
Software
The Folding@home client consists of three separate components.
- The client software acts as a download and file manager for work units and scientific cores, controls the cores, and is the software that the user interacts with. Separating the client from the core enables the scientific methods to be updated automatically (or new methods to be added) without a client update.
- The Work Unit is the actual data that the client is being asked to process.
- The Core performs the calculations on the work unit. Folding@homes cores are based on modified versions of seven molecular simulation programs for calculation: TINKER, GROMACS, AMBER, CPMD, SHARPEN, ProtoMol and Desmond.[10][11] Where possible, optimizations are used to speed the process of calculation. There are many variations on these base simulation programs, each of which is given an arbitrary identifier (Core xx):[12]
Active Cores
- GROMACS (all variants of this core use SIMD optimizations including SSE, 3DNow+ or AltiVec, where available, unless otherwise specified)
- Gromacs (Core 78)
- Available for all Uniprocessor clients only.
- DGromacs (Core 79)
- Double precision Gromacs, uses SSE2 only.
- Available for all Uniprocessor clients only.
- DGromacsB (Core 7b)
- DGromacsC (Core 7c)
- GBGromacs (Core 7a)
- Gromacs with the Generalized Born implicit solvent model.
- Available for all Uniprocessor clients only.
- Gromacs SREM (Core 80)
- Gromacs Serial Replica Exchange Method.
- The Gromacs Serial Replica Exchange Method core, also known as GroST (Gromacs Serial replica exchange with Temperatures), uses the Replica Exchange method (also known as REMD or Replica Exchange Molecular Dynamics) in its simulations.
- Available for Windows and Linux Uniprocessor clients only.
- GroSimT (Core 81)
- Gromacs with Simulated Tempering.
- Available for Windows and Linux Uniprocessor clients only.
- Gromacs 33 (Core a0)
- Uses the Gromacs 3.3 codebase.
- Available for all Uniprocessor clients only.
- Gro-SMP (Core a1)
- Symmetric MultiProcessing variant, locked to four threads (but can be run on dual core processors).
- Runs only on multi-core x86 or x64 hardware.
- Available for all SMP clients only.
- GroCVS (Core a2)
- Symmetric MultiProcessing variant with scalable numbers of threads.
- Runs only on multi-core x86 or x64 hardware, with four or more cores.
- Uses the Gromacs 4.0 codebase.
- Available for Linux and Mac OS X SMP clients only.
- Gro-A3 core (Core a3)
- SMP version of the Gromacs A4 core.
- Uses threads rather than MPI for multicore support.
- Available for SMP2 client only.
- In open beta testing before general release.
- Released January 24th, 2010.
- Gro-A4 (Core a4)
- A single core version of the Gromacs SMP2 core.
- Available for Windows and Linux Uniprocessor clients only.
- GroGPU2 (Core 11)
- Graphics Processing Unit variant for ATI CAL-enabled and nVidia CUDA-enabled GPUs.
- Comes in two separate versions, one each for ATI and nVidia, but both have the same Core ID.
- GPUs do not support SIMD optimizations by design, so none are used in this core.
- Available for GPU2 client only.
- ATI-DEV (Core 12)
- Graphics Processing Unit developmental core for ATI CAL-enabled GPUS.
- Does not support SIMD optimizations.
- Available for GPU2 client only.
- NVIDIA-DEV (Core 13)
- Graphics Processing Unit developmental core for nVidia CUDA-enabled GPUs.
- Does not support SIMD optimizations.
- Available for GPU2 client only.
- GroGPU2-MT (Core 14)[13]
- Graphics Processing Unit variant for nVidia CUDA-enabled GPUs.
- Contains additional debugging code compared to the standard Core 11.
- Does not support SIMD optimizations.
- Released March 2, 2009.
- Available for GPU2 client only.
- Gro-PS3 (Does not have a known ID number, but also called SCEARD core)
- PlayStation 3 variant.
- No SIMD optimizations, uses SPE cores for optimization.
- Available for PS3 client only.
- Gromacs (Core 78)
- AMBER
- PMD (Core 82)[12]
- No optimizations.
- Available for Windows and Linux Uniprocessor clients only.
- PMD (Core 82)[12]
Inactive Cores
- TINKER
- Tinker core (Core 65)
- Currently inactive, as the GBGromacs core (Core 7a) performs the same tasks much faster.
- No optimizations.
- Available for all Uniprocessor clients only.
- Tinker core (Core 65)
- GROMACS
- GroGPU (Core 10)
- Graphics Processing Unit variant for ATI series 1xxx GPUs.
- GPUs do not have optimizations; no SIMD optimizations needed since GPU cores are explicitly designed for SIMD.
- Inactive as of June 6, 2008 due to end of distribution of GPU1 client units.
- Available for GPU1 client only.
- GroGPU (Core 10)
- CPMD
- QMD (Core 96)
- Currently inactive, due to QMD developer graduating from Stanford University and due to current research shifting away from Quantum MD.
- Caused controversy due to SSE2 issues involving Intel libraries and AMD processors.[14]
- Uses SSE2 (currently only on Intel CPUs, see above).
- Available for Windows and Linux Uniprocessor clients only.
- QMD (Core 96)
- SHARPEN [15]
- SHARPEN Core [16]
- Currently inactive, in closed beta testing before general release.
- Uses different format to standard F@H cores, as there is more than one "Work Unit" (using the normal definition) in each work packet sent to clients.
- SHARPEN Core [16]
- Desmond
- Desmond Core
- Currently inactive, in closed beta testing before general release.
- Will be available for Uniprocessor and SMP2 clients.
- Desmond Core
- ProtoMol [7]
- Protomol Core (Core b4)
- Currently inactive, in closed beta testing before general release.
- Protomol Core (Core b4)
- OpenMM
- OpenMM Core (Core 15)
- Currently inactive, in closed beta testing before general release.
- Uses OpenCL to increase reliability and performance on GPUs.
- May unify the ATI and nVidia GPU codebases (due to using OpenCL).
- Will be available for GPU3 client only.
- OpenMM Core (Core 15)
Participation
Shortly after breaking the 200,000 active CPU count on September 20, 2005, the Folding@home project celebrated its fifth anniversary on October 1, 2005.
Interest and participation in the project has grown steadily since its launch. The number of active devices participating in the project increased substantially after receiving much publicity during the launch of their high performance clients for both ATi graphics cards and the PlayStation 3, and again following the launch of the high performance client for nVidia graphics cards.
As of April 9, 2009 the peak speed of the project overall has reached over 5.0 native PFLOPS (8.1 x86 PFLOPS[17]) from around 400,000 active machines, and the project has received computational results from over 4.51 million devices since it first started.[3]
Google & Folding@home
There used to be cooperation between Folding@home and Google Labs in the form of Google Toolbar. Google Compute supported Folding@home during its early stage — when Folding@home had about 10,000 active CPUs. At that time, a boost of 20,000 machines was very significant. Today the project has a large number of active CPUs and the number of new clients joining Google Compute was very low (most people opted for the Folding@home client instead), it is available here (must access in IE with old version of Google Toolbar). The Google Compute clients also had certain limits: they could only run the TINKER core and had limited naming and team options. Folding@home is no longer supported on Google Toolbar, and even the old Google Toolbar client will not work.[18]
Genome@home
Folding@home absorbed the Genome@home project on March 8, 2004. The work which was started by the Genome@home project has since been completed using the Folding@home network (the work units without deadlines), and no new work is being distributed by this project. All donators were encouraged to download the Folding@home client (the F@h 4.xx client had a Genome@home option), and once the Genome@home work was complete these clients were asked to donate their processing power to the Folding@home project instead.
PetaFLOPS milestones
Native petaFLOPS Barrier | Date Crossed |
---|---|
1.0 | September 16, 2007 |
2.0 | early May 2008 |
3.0 | August 20, 2008 |
4.0 | September 28, 2008 |
5.0 | February 18, 2009 |
On September 16, 2007, the Folding@home project officially attained a sustained performance level higher than one native petaFLOPS, becoming the first computing system of any kind in the world to ever do so, although it had briefly peaked above one native petaFLOPS in March 2007, receiving a large amount of main stream media coverage for doing so.[19][20] In early May 2008 the project attained a sustained performance level higher than two native petaFLOPS, followed by the three and four native petaFLOPS milestones on August 20 and September 28, 2008 respectively. On February 18, 2009, Folding@home achieved a performance level of just above 5 petaFLOPS, thereby becoming the first computing system of any kind to surpass 5 native PFLOPS[21], just as it was for the other four milestones.
The Folding@home computing cluster currently operates at above 4.3 native petaFLOPS at all times, with a large majority of the performance coming from GPU and PlayStation 3 clients.[3] In comparison to this, the fastest standalone supercomputer (non-distributive computing) in the world (as of November 2008, U.S. Department of Energy Roadrunner) peaks at approximately 1.46 petaFLOPS.[22]
Beginning in April 2009, Folding@Home began reporting performance in both "Native" FLOPS and x86 FLOPS.[3] ("x86" FLOPS reported at a much higher mark than the "Native" FLOPS) A detailed explanation of the difference between the two figures was given in the FLOP section of the Folding@Home FAQ.[17]
Results
These peer-reviewed papers (in chronological order) all use research from the Folding@home project.[8]
2000–2001
- M. R. Shirts and V. S. Pande. (2000). "Screen Savers of the World, Unite!". Science 290: 1903–1904. doi: . PMID 17742054.
- Michael R. Shirts and Vijay S. Pande (2001). "Mathematical Analysis of Coupled Parallel Simulations". Physical Review Letters 86 (22): 4983–4987. doi: .
- Bojan Zagrovic, Eric J. Sorin and Vijay Pande (2001). "b-Hairpin Folding Simulations in Atomistic Detail Using an Implicit Solvent Model". Journal of Molecular Biology 313: 151–169. doi: .
2002
- Stefan M. Larson, Christopher D. Snow, Michael R. Shirts, and Vijay S. Pande (2002) "Folding@home and Genome@home: Using distributed computing to tackle previously intractable problems in computational biology", Stefan M. Larson, Christopher D. Snow, Michael R. Shirts, and Vijay S. Pande. To appear in Computational Genomics, Richard Grant, editor, Horizon Press
- Bojan Zagrovic, Christopher D. Snow, Michael R. Shirts, and Vijay S. Pande. (2002). "Simulation of Folding of a Small Alpha-helical Protein in Atomistic Detail using Worldwide distributed Computing". Journal of Molecular Biology 323: 927–937. doi: .
- Bojan Zagrovic, Christopher D. Snow, Siraj Khaliq, Michael R. Shirts, and Vijay S. Pande (2002). "Native-like Mean Structure in the Unfolded Ensemble of Small Proteins". Journal of Molecular Biology 323: 153–164. doi: .
- Christopher D. Snow, Bojan Zagrovic, and Vijay S. Pande (2002). "The Trp Cage: Folding Kinetics and Unfolded State Topology via Molecular Dynamics Simulations". Journal of the American Chemical Society 124: 14548–14549. doi: .
2003
- Vijay S. Pande, Ian Baker, Jarrod Chapman, Sidney P. Elmer, Siraj Khaliq, Stefan M. Larson, Young Min Rhee, Michael R. Shirts, Christopher D. Snow, Eric J. Sorin, Bojan Zagrovic (2003). "Atomistic protein folding simulations on the submillisecond timescale using worldwide distributed computing". Biopolymers 68: 91–109. doi: .
- Young Min Rhee & Vijay S. Pande (2003). "Multiplexed-Replica Exchange Molecular Dynamics Method for Protein Folding Simulation". Biophysical Journal 84 (2): 775–786. doi: .
- Eric J. Sorin, Young Min Rhee, Bradley J. Nakatani & Vijay S. Pande (2003). "Insights Into Nucleic Acid Conformational Dynamics from Massively Parallel Stochastic Simulations". Biophysical Journal 85: 790–803. doi: .
- Bojan Zagrovic and Vijay S. Pande (2003). "Solvent Viscosity Dependence of the Folding Rate of a Small Protein: Distributed Computing Study". Journal of Computational Chemistry 24 (12): 1432–1436. doi: .
- Michael R. Shirts, Jed W. Pitera, William C. Swope, and Vijay S. Pande (2003). "Extremely precise free energy calculations of amino acid side chain analogs: Comparison of common molecular mechanics force fields for proteins". Journal of Chemical Physics 119 (11): 5740–5761. doi: .
- Michael R. Shirts, Eric Bair, Giles Hooker, and Vijay S Pande (2003). "Equilibrium Free Energies from Nonequilibrium Measurements Using Maximum-Likelihood Methods". Physical Review Letters 91 (14). doi: .
- Bojan Zagrovic & Vijay S Pande (2003). "Structural correspondence between the alpha-helix and the random-flight chain resolves how unfolded proteins can have native-like properties". Nature Structural Biology 10 (11): 955–961. doi: .
2004
- Eric J. Sorin, Bradley J. Nakatani, Young Min Rhee, Guha Jayachandran, V Vishal, & Vijay S Pande (2004). "Does Native State Topology Determine the RNA Folding Mechanism?". Journal of Molecular Biology 337: 789–757. doi: .
- Christopher D. Snow, Linlin Qiu, Deguo Du, Feng Gai, Stephen J. Hagen, & Vijay S Pande (2004). "Trp zipper folding kinetics by molecular dynamics and temperature-jump spectroscopy". Proceedings of the National Academy of Sciences, USA 101 (12): 4077–4082. doi: .
- Young Min Rhee, Eric J. Sorin, Guha Jayachandran, Erik Lindahl, & Vijay S Pande (2004). "Simulations of the role of water in the protein-folding mechanism". Proceedings of the National Academy of Sciences, USA 101 (17): 6456–6461. doi: .
- Nina Singhal, Christopher D. Snow, and Vijay S. Pande (2004). "Using path sampling to build better Markovian state models: Predicting the folding rate and mechanism of a tryptophan zipper beta hairpin". Journal of Chemical Physics 121: 415–425. doi: .
- L. T. Chong, C. D. Snow, Y. M. Rhee, and V. S. Pande. (2004). "Dimerization of the p53 Oligomerization Domain: Identification of a Folding Nucleus by Molecular Dynamics Simulations". Journal of Molecular Biology 345: 869–878. doi: .
2005
- Eric J. Sorin, Young Min Rhee, and Vijay S. Pande (2005). "Does Water Play a Structural Role in the Folding of Small Nucleic Acids?". Biophysical Journal 88: 2516–2524. doi: .
- Eric J. Sorin and Vijay S. Pande (2005). "Exploring the Helix-Coil Transition via All-atom Equilibrium Ensemble Simulations". Biophysical Journal 88: 2472–2493. doi: .
- Eric J. Sorin and Vijay S. Pande (2005). "Empirical Force-Field Assessment: The Interplay Between Backbone Torsions and Noncovalent Term Scaling". Journal of Computational Chemistry 26: 682–690. doi: .
- C. D. Snow, E. J. Sorin, Y. M. Rhee, and V. S. Pande. (2005). "How well can simulation predict protein folding kinetics and thermodynamics?". Annual Reviews of Biophysics 34: 43–69. doi: .
- Bojan Zagrovic, Jan Lipfert, Eric J. Sorin, Ian S. Millett, Wilfred F. van Gunsteren, Sebastian Doniach & Vijay S. Pande (2005). "Unusual compactness of a polyproline type II structure". Proceedings of the National Academy of Sciences, USA 102 (33): 11698–11703. doi: .
- Michael R. Shirts & Vijay S. Pande (2005). "Comparison of efficiency and bias of free energies computed by exponential averaging, the Bennett acceptance ratio, and thermodynamic integration". Journal of Chemical Physics 122. doi: .
- Michael R. Shirts & Vijay S. Pande (2005). "Solvation free energies of amino acid side chain analogs for common molecular mechanics water models". Journal of Chemical Physics 122. doi: .
- Sidney Elmer, Sanghyun Park, & Vijay S. Pande (2005). "Foldamer dynamics expressed via Markov state models. I. Explicit solvent molecular-dynamics simulations in acetonitrile, chloroform, methanol, and water". Journal of Chemical Physics 123. doi: .
- Sidney Elmer, Sanghyun Park, & Vijay S. Pande (2005). "Foldamer dynamics expressed via Markov state models. II. State space decomposition". Journal of Chemical Physics 123. doi: .
- Sanghyun Park, Randall J. Radmer, Teri E. Klein, and Vijay S. Pande (2005). "A New Set of Molecular Mechanics Parameters for Hydroxyproline and Its Use in Molecular Dynamics Simulations of Collagen-Like Peptides". Journal of Computational Chemistry 26: 1612–1616. doi: .
- Hideaki Fujutani, Yoshiaki Tanida, Masakatsu Ito, Guha Jayachandran, Christopher D. Snow, Michael R. Shirts, Eric J. Sorin, and Vijay S. Pande (2005). "Direct calculation of the binding free energies of FKBP ligands using the Fujitsu BioServer massively parallel computer". Journal of Chemical Physics 123. doi: .
- Nina Singhal and Vijay S. Pande (2005). "Error Analysis and efficient sampling in Markovian State Models for protein folding". Journal of Chemical Physics 123. doi: .
- Bojan Zagrovic, Guha Jayachandran, Ian S. Millett, Sebastian Doniach and Vijay S. Pande (2005). "How large is alpha-helix in solution? Studies of the radii of gyration of helical peptides by SAXS and MD". Journal of Chemical Physics 353: 232–241. doi: .
2006
- Paula Petrone and Vijay S. Pande (2006). "Can conformational change be described by only a few normal modes?". Biophysical Journal 90: 1583–1593. doi: .
- Eric J. Sorin, Young Min Rhee, Michael R. Shirts, and Vijay S. Pande (2006). "The solvation interface is a determining factor in peptide conformational preferences". Journal of Molecular Biology 356: 248–256. doi: .
- Eric J. Sorin and Vijay S. Pande (2006). "Nanotube confinement denatures protein helices". Journal of the American Chemical Society 128: 6316–6317. doi: .
- Young Min Rhee and Vijay S. Pande (2006). "On the role of chemical detail in simulating protein folding kinetics". Chemical Physics 323: 66–77. doi: .
- L.T. Chong, W. C. Swope, J. W. Pitera, and V. S. Pande (2006). "A novel approach for computational alanine scanning: application to the p53 oligomerization domain". Journal of Molecular Biology 357 (3): 1039–1049. doi: .
- I. Suydam, C. D. Snow, V. S. Pande and S. G. Boxer. (2006). "Electric Fields at the Active Site of an Enzyme: Direct Comparison of Experiment with Theory". Science 313 (5784): 200–204. doi: .
- P. Kasson, N. Kelley, N. Singhal, M. Vrjlic, A. Brunger, and V. S. Pande (2006). "Ensemble molecular dynamics yields submillisecond kinetics and intermediates of membrane fusion". Proceedings of the National Academy of Sciences, USA 103 (32): 11916–11921. doi: .
- Guha Jayachandran, V. Vishal, and V. S. Pande (2006). "Folding Simulations of the Villin Headpiece in All-Atom Detail". Journal of Chemical Physics 124. doi: .
- Guha Jayachandran, M. R. Shirts, S. Park, and V. S. Pande (2006). "Parallelized Over Parts Computation of Absolute Binding Free Energy with Docking and Molecular Dynamics". Journal of Chemical Physics 125. doi: .
- C. Snow and V. S. Pande (2006). "Kinetic Definition of Protein Folding Transition State Ensembles and Reaction Coordinates". Biophysical Journal 91: 14–24. doi: .
- S. Park and V. S. Pande (2006). "A Bayesian Update Method for Adaptive Weighted Sampling". Physical Review 74 (6). doi: .
- P. Kasson and V. S. Pande (2006). "Predicting structure and dynamics of loosely-ordered protein complexes: influenza hemagglutinin fusion peptide". PSB. doi: . PMID 17992744.
- Erich Elsen, Mike Houston, V. Vishal, Eric Darve, Pat Hanrahan, and Vijay Pande (2006). "N-Body simulation on GPUs". Proceedings of the 2006 ACM/IEEE conference on Supercomputing. doi: .
2007
- Guha Jayachandran, V. Vishal, Angel E. Garcıa and V. S. Pande (2007). "Local structure formation in simulations of two small proteins". Journal of Structural Biology 157 (3): 491–499. doi: .
- Adam L Beberg and Vijay S. Pande (2007). "Storage@home: Petascale Distributed Storage". IPDPS. doi: .
- J. Chodera, N. Singhal, V. S. Pande, K. Dill, and W. Swope (2007). "Automatic discovery of metastable states for the construction of Markov models of macromolecular conformational dynamics". Journal of Chemical Physics 126 (15). PMID 17461665.
- D. Lucent, V. Vishal, V. S. Pande (2007). "Protein folding under confinement: a role for solvent". Proceedings of the National Academy of Sciences, USA 104 (25): 10430–10434. doi: .
- P. M. Kasson, A. Zomorodian, S. Park, N. Singhal, L. J. Guibas, and V. S. Pande (2007). "Persistent voids: a new structural metric for membrane fusion". Bioinformatics. doi: .
- P. M. Kasson and V. S. Pande (2007). "Control of Membrane Fusion Mechanism by Lipid Composition: Predictions from Ensemble Molecular Dynamics". PLoS Computational Biology 3 (11). doi: .
- D. Ensign, P. M. Kasson, and V. S. Pande (2007). "Heterogeneity Even at the Speed Limit of Folding: Large-scale Molecular Dynamics Study of a Fast-folding Variant of the Villin Headpiece". Journal of Molecular Biology 374 (3): 806–816. doi: .
- Alex Robertson, Edgar Luttmann, Vijay S. Pande (2007). "Effects of long-range electrostatic forces on simulated protein folding kinetics". Journal of Computational Chemistry 29 (5): 694–700. doi: .
- Nina Singhal Hinrichs and Vijay S. Pande (2007). "Calculation of the distribution of eigenvalues and eigenvectors in Markovian state models for molecular dynamics". Journal of Chemical Physics 126. doi: .
2008
- Xuhui Huang, Gregory R. Bowman,and Vijay S. Pande (2008). "Convergence of folding free energy landscapes via application of enhanced sampling methods in a distributed computing environment". Journal of Chemical Physics 128 (20). PMID 18513049.
- Gregory R. Bowman, Xuhui Huang, Yuan Yao, Jian Sun, Gunnar Carlsson, Leonidas J. Guibas, and Vijay S. Pande (2008). "Structural Insight into RNA Hairpin Folding Intermediates". Journal of the American Chemical Society 130 (30): 9676–9678. doi: .
- Nicholas W. Kelley, V. Vishal, Grant A. Krafft, and Vijay S. Pande. (2008). "Simulating oligomerization at experimental concentrations and long timescales: A Markov state model approach.". Journal of Chemical Physics 129 (21). doi: .
- Paula M. Petrone, Christopher D. Snow, Del Lucent, and Vijay S. Pande (2008). "Side-chain recognition and gating in the ribosome exit tunnel". Proceedings of the National Academy of Sciences, USA 105 (43): 16549–16554. doi: .
- Edgar Luttmann, Daniel L. Ensign, Vishal Vaidyanathan, Mike Houston, Noam Rimon, Jeppe Øland, Guha Jayachandran, Mark Friedrichs, Vijay S. Pande (2008). "Accelerating Molecular Dynamic Simulation on the Cell processor and PlayStation 3". Journal of Computational Chemistry 30 (2): 268–274. doi: .
2009
- Peter M. Kasson and Vijay S. Pande (2009). "Combining Mutual Information with Structural Analysis to Screen for Functionally Important Residues in Influenza Hemagglutinin". Pacific Symposium on Biocomputing 14: 492–503. PMID 19209725.
- Nicholas W. Kelley, Xuhui Huang, Stephen Tam, Christoph Spiess, Judith Frydman and Vijay S. Pande (2009). "The predicted structure of the headpiece of the Huntingtin protein and its implications on Huntingtin aggregation". Journal of Molecular Biology. doi: .
- M. S. Friedrichs, P. Eastman, V. Vaidyanathan, M. Houston, S. LeGrand, A. L. Beberg, D. L. Ensign, C. M. Bruns, V. S. Pande (2009). "Accelerating molecular dynamic simulation on graphics processing units". Journal of Computational Chemistry. doi: . PMID 19191337.
- D. L. Ensign and V. S. Pande (2009). "The Fip35 WW Domain Folds with Structural and Mechanistic Heterogeneity in Molecular Dynamics Simulations". Biophysical Journal 96 (8): L53-55. PMID 19383445.
- V. A. Voelz, E. Luttmann, G. R. Bowman, and V.S. Pande (2009). "Probing the nanosecond dynamics of a designed three-stranded beta-sheet with massively parallel molecular dynamics simulation". International Journal of Molecular Sciences 10 (3): 1013. doi: .
- A. Beberg and V. S. Pande (2009). "Folding@home: lessons from eight years of distributed computing". IEEE International Parallel and Distributed Processing Symposium: 1-8. doi: .
- G. R. Bowman, X. Huang, and V. S. Pande (2009). "Using generalized ensemble simulations and Markov state models to identify conformational states". Methods 49 (2): 197-201. doi: .
- G. R. Bowman and V. S. Pande (2009). "The Roles of Entropy and Kinetics in Structure Prediction". PLoS One 4 (6): e5840. doi: .
- Peter M. Kasson, Daniel L. Ensign and Vijay S. Pande (2009). "Combining Molecular Dynamics with Bayesian Analysis To Predict and Evaluate Ligand-Binding Mutations in Influenza Hemagglutinin". Journal of the American Chemical Society. PMID 19637916.
- S. Bacallado, J. Chodera, and V. Pande (2009). "Bayesian comparison of Markov models of molecular dynamics with detailed balance constraint". Journal of Chemical Physics 131. doi: .
2010
- Vincent A. Voelz, Gregory R. Bowman, Kyle Beauchamp and Vijay S. Pande (2010). "Molecular Simulation of ab Initio Protein Folding for a Millisecond Folder NTL9(1−39)". Journal of the American Chemical Society. doi: .
High performance platforms
Graphical processing units
On October 2, 2006, the Folding@home Windows GPU client was released to the public as a beta test. After 9 days of processing from the Beta client the Folding@home project had received 31 teraFLOPs of computational performance from just 450 ATI Radeon X1900 GPUs, averaging at over 70x the performance of current CPU submissions, and the GPU clients remain the most powerful clients available in performance per client (as of March 11, 2009, GPU clients accounted for over 60% of the entire project's throughput at an approximate ratio of 9 clients per teraFLOP).[3] On April 10, 2008, the second generation Windows GPU client was released to open beta testing, supporting ATI/AMD's Radeon HD 2000 and HD 3000 series, and also debuting a new core (GROGPU2 - Core 11). Inaccuracies with DirectX were cited as the main reason for the migration to the new version (the original GPU client was officially retired June 6, 2008[23]), which uses AMD/ATI's CAL. On June 17, 2008, a version of the second-generation Windows GPU client for CUDA enabled Nvidia GPUs was also released for public beta testing.[24] The GPU clients proved reliable enough to be promoted out of the beta phase and were officially released August 1, 2008.[25] Newer GPU cores continue to be released for both CAL and CUDA.
While the only officially released GPU v2.0 client is for Windows, this client can be run on Linux under Wine with NVIDIA graphics cards.[26] The client can operate on both 32- and 64-bit Linux platforms, but in either case the 32-bit CUDA toolkit is required. This configuration is not officially supported, though initial results have shown comparable performance to that of the native client and no problems with the scientific results have been found[citation needed]. An unofficial installation guide has been published.[26]
On September 25, 2009, Vijay Pande revealed in his blog that a new third version of the GPU client was in development.[27] GPU3 will use OpenCL (preferred over DirectX 11's Compute Shaders) as the software interface, which may mean that the GPU core will be unified for both ATI and nVidia, and may also mean the addition of support for other platforms with OpenCL support.
PlayStation 3
Stanford announced in August 2006 that a folding client was available to run on the Sony PlayStation 3.[28] The intent was that gamers would be able to contribute to the project by merely "contributing electricity", leaving their PlayStation 3 consoles running the client while not playing games. PS3 firmware version 1.6 (released on Thursday, March 22, 2007) allows for Folding@home software, a 50 MB download, to be used on the PS3.[3] A peak output of the project at 990 teraFLOPS was achieved on March 25, 2007, at which time the number of FLOPS from each PS3 as reported by Stanford fell, reducing the overall speed rating of those machines by 50%. This had the effect of bumping down the overall project speed to the mid 700 range and increasing the number of active PS3s required to achieve a petaFLOPS level to around 60,000.
On April 26, 2007, Sony released a new version of Folding@home which improved folding performance drastically, such that the updated PS3 clients produced 1500 teraFLOPS with 52,000 clients versus the previous 400 teraFLOPS by around 24,000 clients.[29] Lately, the console accounts for around 26% of all teraFLOPS at an approximate ratio of 35½ PS3 clients per teraFLOPS.
On December 19, 2007, Sony again updated the Folding@home client to version 1.3 to allow users to run music stored on their hard drives while contributing. Another feature of the 1.3 update allows users to automatically shut down their console after current work is done or after a limited period of time (for example 3 or 4 hours). Also, the software update added the Generalized Born implicit solvent model, so the FAH PS3 client gained more broad computing capabilities.[30][31] Shortly afterward, 1.3.1 was released to solve a mishandling of protocol resulting in difficulties sending and receiving Work Units due to heavy server loads stemming from the fault.
On September 18, 2008 the Folding@home client became Life With PlayStation. In addition to the existing functionality, the application also provides the user with access to information "channels", the first of which being the Live Channel which offers news headlines and weather through a 3D globe. The user can rotate and zoom in to any part of the world to access information provided by Google News and The Weather Channel, among other sources, all running whilst folding in the background. This update also provided more advanced simulation of protein folding and a new ranking system.[32]
Multi-core processing client
As more modern CPUs are being released, the migration to multiple cores is becoming more adopted by the public, and the Pande Group is adding symmetric multiprocessing (SMP) support to the Folding@home client in the hopes of capturing the additional processing power. The SMP support is being achieved by utilizing Message Passing Interface (MPI) protocols. In current state it is being confined inside a single node by hard coded usage of the localhost.
On November 13, 2006, the beta SMP Folding@home clients for x86-64 Linux and x86 Mac OS X were released. The beta win32 SMP Folding@home client is out as well, and a 32-bit Linux client is currently in development.[33]
On June 17, 2009 the Pande Group revealed that a second generation SMP client (known as the SMP2 client) was in development. This client will use threads rather than MPI[11] to spread the processing load across multiple cores and thereby remove the overhead of keeping the cores synced, as they should share a common data bank in RAM. On January 24th, 2010, the first open beta release of the SMP2 client was made, trialling the new processing methods and a new points bonus system rewarding quick unit returns.
Folding@home teams
A typical Folding@home user, running the client on a single PC, will likely not be ranked high on the list of contributors. However, if the user were to join a team, they would add the points they receive to a larger collective. Teams work by using the combined score of all their members. Thus, teams are ranked much higher than individual submitters. Rivalries between teams create friendly competition that benefits the folding community. Many teams publish their own stats, so members can have intra-team competitions for top spots.[34] Some teams offer prizes in an attempt to increase participation in the project.[35][36]
Development
The Folding@home project does not make the project source code available to the public, citing security and integrity concerns.[37][38] At the same time, the majority of the scientific codes used by the FAH (ex. Cosm, GROMACS, TINKER, AMBER, CPMD, BrookGPU) are largely Open-source software or under similar licenses.
A development version of Folding@home once ran on the open source BOINC framework; however, this version remained unreleased.[39]
Estimated energy consumption
A PlayStation 3 has a maximum power rating of 380 watts. As Folding@home is a CPU intensive application, it causes 100% utilization. However, according to Stanford's PS3 FAQ, "We expect the PS3 to use about 200W while running Folding@home."[40] As of December 27, 2008, there are 55,291 PS3s providing 1,559,000,000 MFlops of processing power. This amounts to 28,196 MFlops/PS3, and with Stanford's estimate of 200W per PS3 (for original units manufactured on the 90 nm process), 140.98 MFlops/watt.[3] This would put the PS3 portion of Folding@home at 95th on the November 2008 Green500 list.[41] The Cell processors used in 65 nm PlayStation 3s lower power consumption to around 140W per PS3, whilst the 45 nm PS3s reduce this again to around 100W. This further increases the power efficiency of the contribution from PlayStation 3 units.
The total power consumption required to produce the processing power required by the project can be estimated based upon the average FLOPS per watt. As of November 2008, according to the Green500 list, the most efficient computer - also based on a version of the Cell BE - runs at 536.24 MFLOPS/watt.[42] One petaFLOPS equals 1,000,000,000 MFLOPSs. Therefore, the current Folding@home project, if it were theoretically using the most efficient CPUs currently available, would use at least 2.8 megawatts of power per petaFLOPS, slightly more than the world's first and only petaflop system, the Cell-based Roadrunner which uses 2.345MW. This is equivalent to the power needed to light approximately 40,000 standard house light bulbs (between 60 and 100 watts each), or the equivalent of 1-3 wind turbines depending on their size.[43]
Estimates of energy usage per time period are more difficult than estimates of energy usage per processing instruction. This is because Folding@home clients are often run on computers that would be powered-on even in the absence of the Folding@home client, and that run other programs simultaneously. While Folding@home increases processor utilization, and thus (usually) power consumption, the extent to which it does so is dependent on the client processor's normal operating load, and its ability to reduce clock speeds when presented with less-than-full utilization (a process known as dynamic frequency scaling). Consequently, the total power usage of the Folding@home client on a temporal basis is probably less than the figure that could be calculated by summing the peak power consumption of each of the project's component processors.
Also, in a Folding@home client that is run on a home computer where a heating system is being used, the excess heat generated by the power usage would theoretically reduce the amount of energy needed to heat the building.[citation needed] However, any such energy gains would be more than offset by the need for cooling during the warmer months.
Anticipated hardware performance
In 2009 the hardware performance database using the Google sites and docs platform was established.[44] This allows users to add their performance data to a database that can keep track of different variables. This is designed to be an aid to new users who are curious as to how well their system is performing compared to others.[44]
See also
- Blue Gene
- Grid computing
- List of distributed computing projects
- Rosetta@home
- Software for molecular modeling
- Molecular modeling on GPU
References
- ↑ http://folding.stanford.edu/English/License
- ↑ Engadget, among other sites, announces that Guinness has recognized FAH as the most powerful distributed cluster, October 31, 2007. Retrieved November 5, 2007
- ↑ 3.0 3.1 3.2 3.3 3.4 3.5 3.6 "Client Statistics by OS". Folding@home distributed computing. Stanford University. 2006-11-12 (updated automatically). http://fah-web.stanford.edu/cgi-bin/main.py?qtype=osstats. Retrieved 2008-01-05.
- ↑ Vijay Pande (2006). "Folding@home distributed computing home page". Stanford University. http://folding.stanford.edu. Retrieved 2006-11-12.
- ↑ "Folding@home diseases studied FAQ". Stanford University. http://folding.stanford.edu/FAQ-diseases.html.
- ↑ "Futures in Biotech 27: Folding@home at 1.3 Petaflops" (Interview, webcast). http://twit.tv/fib27.
- ↑ 7.0 7.1 "Folding@home - About" (FAQ). http://folding.stanford.edu/English/About.
- ↑ 8.0 8.1 Vijay Pande and the Folding@home team (2009). "Folding@home - Papers". Folding@home distributed computing. Stanford University. http://folding.stanford.edu/English/Papers. Retrieved 2009-12-23.
- ↑ C. Snow, H. Nguyen, V. S. Pande, and M. Gruebele. (2002). "Absolute comparison of simulated and experimental protein-folding dynamics". Nature 420 (6911): 102–106. doi: . PMID 12422224.
- ↑ Vijay Pande (2005-10-16). "Folding@home with QMD core FAQ" (FAQ). Stanford University. http://folding.stanford.edu/QMD.html. Retrieved 2006-12-03. The site indicates that Folding@home uses a modification of CPMD allowing it to run on the supercluster environment.
- ↑ 11.0 11.1 Vijay Pande (2009-06-17). "Folding@home: How does FAH code development and sysadmin get done?". http://folding.typepad.com/news/2009/06/how-does-fah-code-development-and-sysadmin-get-done.html. Retrieved 2009-06-25.
- ↑ 12.0 12.1 "Cores - FaHWiki" (FAQ). http://fahwiki.net/index.php/Cores. Retrieved 2007-11-06.
- ↑ "Folding Forum: Announcing project 5900 and Core_14 on advmethods". 2009. http://foldingforum.org/viewtopic.php?f=52&t=8734&start=0. Retrieved 2009-03-02.
- ↑ "FAH & QMD & AMD64 & SSE2" (FAQ). http://fahwiki.net/index.php/FAH_&_QMD_&_AMD64_&_SSE2.
- ↑ "SHARPEN: Systematic Hierarchical Algorithms for Rotamers and Proteins on an Extended Network" (About). http://p450.caltech.edu/sharpen/sharpenabout.html.
- ↑ "SHARPEN". http://p450.caltech.edu/sharpen/sharpenprojects.html.
- ↑ 17.0 17.1 Folding@home FLOP FAQ
- ↑ "What is the state of Google Compute client?" (Blog). Folding@home support forum. Stanford University. http://forum.folding-community.org/fpost151025.html. Retrieved 2006-11-12.
- ↑ Folding@home: Crossing the petaFLOPS barrier
- ↑ Folding@home: Post petaflop
- ↑ "Folding@home passes the 5 petaflop mark" from the official Folding@home blog
- ↑ "TOP500 Roadrunner Performance Data". http://www.top500.org/system/performance/9707. Retrieved 2008-12-27.
- ↑ "Folding@home: GPU1 has been retired, GPU2 for NVIDIA release nearing". http://folding.typepad.com/news/2008/06/gpu1-has-been-retired-gpu2-for-nvidia-release-nearing.html.
- ↑ "Folding@home: GPU2 beta client for NVIDIA now released". http://folding.typepad.com/news/2008/06/gpu2-beta-client-for-nvidia-now-released.html.
- ↑ "Folding@home: New clients are out (6.20)". http://folding.typepad.com/news/2008/08/new-clients-are-out-620.html.
- ↑ 26.0 26.1 "Folding@Home GPU v2.0 Windows Client on Linux Wiki". 2008-08-23. http://gpu2.twomurs.com/index.php?title=Main_Page. Retrieved 2008-11-06.
- ↑ "Folding@home: Update on new FAH core and clients". http://folding.typepad.com/news/2009/09/update-on-new-fah-cores-and-clients.html.
- ↑ Vijay Pande (2006-10-22). "PS3 FAQ". Stanford University. http://folding.stanford.edu/FAQ-PS3.html. Retrieved 2006-11-13.
- ↑ "PS3 Folding Kicking Ass, Getting Update". http://kotaku.com/gaming/folding%40home/ps3-folding-kicking-ass-getting-update-255086.php.
- ↑ "Folding@home for PLAYSTATION3 Version 1.3". http://www.scei.co.jp/folding/en/update.html. Retrieved 2007-12-31.
- ↑ Rimon, Noam (2007-12-18). "New Folding@home Features Coming". http://blog.us.playstation.com/2007/12/18/new-foldinghome-features-coming/. Retrieved 2007-12-31.
- ↑ "Life With PlayStation out now". Kotaku. http://kotaku.com/5051551/life-with-playstation-out-now.
- ↑ Vijay Pande (2006-11-13). "Folding@home SMP Client FAQ". Stanford University. http://folding.stanford.edu/FAQ-SMP.html. Retrieved 2006-11-13.
- ↑ Folding-community: why have teams?
- ↑ "The Mprize-". http://www.mprize.org/index.php?ctype=news&pagename=blogdetaildisplay&BID=2008032-20053630&detaildisplay=Y.
- ↑ Team Jiggmin F@H Prizes
- ↑ "Why not OpenSource?". http://folding-community.org/viewtopic.php?p=178218&highlight=#178218.
- ↑ "Folding@home Open Source FAQ". http://folding.stanford.edu/English/FAQ-OpenSource.
- ↑ "FAH on BOINC". Folding@home high performance client FAQ. http://folding.stanford.edu/English/FAQ-highperformance.
- ↑ "PS3 FAQ" (FAQ). http://www.stanford.edu/group/pandegroup/folding/FAQ-PS3.html.
- ↑ "Green 500". http://green500.org/lists/listdisplay.php?month=11&year=2008&list=green500_200811.csv&start=1&line=101.
- ↑ "The Green500 List". http://green500.org/lists/2008/11/list.php. Retrieved 2008-12-27.
- ↑ "Windmill - Wikipedia, the free encyclopedia". http://en.wikipedia.org/wiki/Windmill#Modern_windmills.
- ↑ 44.0 44.1 "002 Tools F@H Performance Data". http://sites.google.com/site/techtdsn/folding-home.
External links
- Folding@home project homepage
- Folding@home Wiki
- FAH-Addict; Folding@home related news
- Kakao Folding@home Stats
- Wikipedia team
- 002 Tools F@H Performance Data
- Talk given by Folding@home author Vijay Pande at the PARC forum
- Folding@home Instructional Video on YouTube
- Interview of Vijay Pande about Folding@Home Project
be:Folding@home be-x-old:Folding@home ca:Folding@home da:Folding@home de:Folding@home es:Folding@home eo:Folding@Home fr:Folding@Home it:Folding@Home he:Folding@home lt:Folding@home nl:Folding@home ja:Folding@Home no:Folding@Home pl:Folding@home pt:Folding@home ru:Folding@home fi:Folding@home
sv:Folding@home tr:Folding@Home uk:Folding@home vi:Folding@home zh-yue:Folding@home zh:Folding@home
If you like SEOmastering Site, you can support it by - BTC: bc1qppjcl3c2cyjazy6lepmrv3fh6ke9mxs7zpfky0 , TRC20 and more...
- Pages where expansion depth is exceeded
- Pages with broken file links
- Articles needing cleanup from September 2009
- Articles with invalid date parameter in template
- All pages needing cleanup
- Wikipedia introduction cleanup from September 2009
- All articles with unsourced statements
- Articles with unsourced statements from November 2008
- Articles with unsourced statements from January 2010
- Protein folds
- Protein structure
- Distributed computing projects
- Windows software
- Linux software
- Mac OS X software
- PlayStation 3 software
- Cross-platform software