SlideShare uma empresa Scribd logo
1 de 15
Baixar para ler offline
Implementing a neural network potential
for exascale molecular dynamics
Saaketh Desai, Sam Reeve, Jim Belak
Lawrence Livermore National Laboratory
School of Materials Engineering, Purdue University
Computational Chemistry and Materials Science (CCMS) Summer Institute 2019
2
Molecular dynamics and machine-learned potentials
Obtain updated
positions and velocities
Start with a set of
positions and velocities
Solve F = ma
Verlet
integration
Define atomic interactions
(interatomic potential)
Lennard-Jones
Ø DFT ~ O(n3
e)
Ø Interatomic potential ~ O(natoms)
Ø Can we get quantum mechanical
accuracy with linear scaling?
𝐸𝑖 = 𝜖 𝑐𝐹 𝛼 (
)*+
𝜌 𝛽 𝑟𝑖𝑗 +
1
2
(
)*+
𝜙 𝛼𝛽 𝑟𝑖𝑗
Embedded Atom Model
Spectral Neighbor Analysis Potential
3
Caution: more than blind ab-initio sim (cf: yesterday)
Can ML be used to identify where new data is needed? How do
we decide if a funny feature is real or an artifact?
4
Descriptor-based machine-learned potentials
Descriptor
Symmetry Functions
SOAP
Bispectrum coefficients
ML method
Neural network
Gaussian Process
Linear Regression
Atomic structure
GAP
SNAP
NNP
MTP
qSNAP
Figure from arXiv:1906.08888 [physics.comp-ph]
EAM
MEAM
Ø Can we improve implementation
to break the pareto front?
5
A closer look at the kernel
traditional
𝑉 𝑟+) =
5
678
9:
−
5
678
<
𝐹𝑜𝑟 𝑎𝑡𝑜𝑚 𝑖 = 1: 𝑁
𝐹𝑜𝑟 𝑒𝑎𝑐ℎ 𝑛𝑒𝑖𝑔ℎ𝑏𝑜𝑟 𝑗 𝑜𝑓 𝑎𝑡𝑜𝑚 𝑖
unique
𝐸IJIKLM = (
+
𝐸+
𝑓+
N
= (
) * +
(
O
𝜕𝐸)
𝜕𝐺),O
∗
𝜕𝐺),O
𝜕𝑟+)
N
𝐺O
𝑟+) = 𝑒
TUV 678 T6WV
X
𝑓Y(𝑟+))
𝐹𝑜𝑟 𝑒𝑎𝑐ℎ 𝑑𝑒𝑠𝑐𝑟𝑖𝑝𝑡𝑜𝑟 𝑘
𝐸+ = 𝑁𝑁 (𝐺+)
𝐹𝑜𝑟 𝑎𝑡𝑜𝑚 𝑖 = 1: 𝑁
𝐹𝑜𝑟 𝑎𝑡𝑜𝑚 𝑖 = 1: 𝑁
1
G1k
G1j
G2j
G2k
atom i neighbor j neighbor k
G1(r)
G2(r)
G3(r)
G4(r)
G1(atom i) = G1j + G1k
G2(atom i) = G2j + G2k
2
3
~30
2
6
Other neural network potentials
Weinan E. et. al., Computer Physics Communications 228 (2018) Schütt, Kristof, et al. Advances in Neural
Information Processing Systems. 2017
GAP SNAPHDNNP SchNet DeepMD
2007 2010 2015 2017 2018 2019
SimpleNN
wACSF
HIP-NN, AIMNet
ANI-1Ø Suggested improvements to HDNNPs
Ø Machine – learned descriptors vs
handcrafted descriptors?
SchNet DeepMD
7
Implementation details
Singraber, Andreas, Jörg Behler, and Christoph Dellago, Journal
of chemical theory and computation 15.3 (2019): 1827-1840. https://github.com/CompPhysVienna/n2p2
Ø Evaluate scaling performance on water
Ø Compare with other potentials published in arXiv:1906.08888 [physics.comp-ph]
n2p2 – LAMMPS CabanaMD
Memory based model (large structs) Cabana AoSoAs/ Kokkos views
Minor explicit OpenMP parallelization Kokkos and Cabana parallelization
Ø Easy to read and modify C++ code
Ø Stand-alone package with no dependencies (Tensorflow etc)
Ø Neural network potential closest to traditional interatomic potentials
Why choose n2p2?
How to implement performance portable version of n2p2?
8
Performance gains by re-implementation
8K atoms
36K atoms
121K atoms
saturating performance
memory-bound
(small systems)
Ø Our implementation scales better,
allowing large system sizes
Ø GPU implementation shows significant
improvement
Ø Intel Broadwell node / Nvidia V100 GPU
n2p2 (LAMMPS)
increasing
performance
n2p2 (LAMMPS)
CPU
GPU
CabanaMD
scales well
worker-bound
8K atoms
36K atoms
CabanaMD
121K atoms
562K atoms
1.5M atoms
4.5M atoms
8K atoms
36K atoms
121K atoms
saturating performance
memory-bound
(small systems)
n2p2 (LAMMPS)
increasing
performance
9
Performance across various systems
GPU – H2O
GPU – Ni
Ni (~1.5M)
H2O (~36K)
strong scaling weak scaling
Ni (~40k per thread)
Ø Ni potential shows vastly superior
performance to H2O (CPU and GPU)
Ø Strong scaling shows parallel efficiency
of around 75%
Ø MPI scaling results coming soon…
10
Data layout for better performance
Ø Neural network still a minor part of
computation
Ø Splitting 6 AoSoAs and changing
vector lengths show minor
improvements on the GPU
Ø Hierarchical parallelism shows
promise, subject to further testing
Ni (CPU)01
08
16
32
01
08
16
32
ForcesNeural
network
Symmetry
Functions
01
08
1632
01
08
16 32Ni (GPU)
Ø We implemented a neural network potential in CabanaMD
using Kokkos/Cabana constructs
Ø Kokkos/Cabana based implementation of neural network
potential offers significant on-node scalability (~4x speedup and
10x larger systems)
Ø First – ever GPU implementation of neural network potential
shows up to 10x improvement over CPU implementation (single
element performance ~ 1 million atomsteps per second)
Ø Data layout changes offer additional ~10% performance gain
Summary and future work
Seeds for Contemplation
12
• CALPHAD uses a power series expansion in temperature,
pressure and constitution
• By analogy to ML potentials, can ML be used to construct free
energies?
• Can ML augment CALPHAD and reveal features not possible
from an analytic fit?
• Are there correlations in multi-component systems revealed
using ML? (not possible using analytic models)
• Can ML be used to identify missing data and/or extend the
thermodynamic data used in CALPHAD assessments?
• How does one maintain thermodynamic consistency using ML?
• What about non-equilibrium free energies?
• What about transition / mixed regions (values of phi between 0
and 1)?
13
CALPHAD / PT is the low hanging fruit
• Liz Holm use machine vision in 2D, Peter’s students are
doing this in 3D.
• Can ML classify unique microstructures? (yes)
• Can ML be used to quantify the “distance” between
microstructure? How close are two microstructures?
Statistically?
• We want to quantitatively compare simulated
microstructure to experimental observation.
14
Classify Microstructures (CNN)
132 B.L. DeCost, E.A. Holm / Computational Materials Science 110 (2015) 126–133
DeCost and Holm, Comp. Mat. Sci. 110 (2015) 126-133
• Billion atom simulations of nucleation /
solidification are becoming routine
(Shibuta, Nature Comm 2017)
• Can ML by used to determine the best
model from simulation or experimental
data?
• Or create an ML model that uses a
know free energy? Generative Model.
15
Model determination (Supervised and GANs)
• Low fruit is determining optimal model parameters (e.g. mobilities)
• Can PFM datasets in a similar ML framework be used to determine
microstructure aware continuum models?
• Nucleation: Can ML be used to detect anomalies in PF simulations?
• Can ML be used to control / steer simulations? Drive design of
experiments (cf. Michael Tonks)?
• Is there an analogy to putting smart sensors into the simulation?

Mais conteúdo relacionado

Mais procurados

Density Functional Theory
Density Functional TheoryDensity Functional Theory
Density Functional Theorykrishslide
 
Graphs, Environments, and Machine Learning for Materials Science
Graphs, Environments, and Machine Learning for Materials ScienceGraphs, Environments, and Machine Learning for Materials Science
Graphs, Environments, and Machine Learning for Materials Scienceaimsnist
 
Neurosynaptic chips
Neurosynaptic chipsNeurosynaptic chips
Neurosynaptic chipsJeffrey Funk
 
Nanotechnology in Defence Sector
Nanotechnology in Defence SectorNanotechnology in Defence Sector
Nanotechnology in Defence Sectorsumeetbrar007
 
Nanoparticle Drug Delivery Systems for Cancer Treatment
Nanoparticle Drug Delivery Systems for Cancer TreatmentNanoparticle Drug Delivery Systems for Cancer Treatment
Nanoparticle Drug Delivery Systems for Cancer TreatmentAranca
 
BIOS 203 Lecture 4: Ab initio molecular dynamics
BIOS 203 Lecture 4: Ab initio molecular dynamicsBIOS 203 Lecture 4: Ab initio molecular dynamics
BIOS 203 Lecture 4: Ab initio molecular dynamicsbios203
 
Nanotechnology: Basic introduction to the nanotechnology.
Nanotechnology: Basic introduction to the nanotechnology.Nanotechnology: Basic introduction to the nanotechnology.
Nanotechnology: Basic introduction to the nanotechnology.Sathya Sujani
 
Machine Learning for Chemical Sciences
Machine Learning for Chemical SciencesMachine Learning for Chemical Sciences
Machine Learning for Chemical SciencesIchigaku Takigawa
 
Quantum dots ppt
Quantum dots ppt Quantum dots ppt
Quantum dots ppt Amit Singh
 
Molecular machines: Delving into the world of Supramolecualr Chemistry
Molecular machines: Delving into the world of Supramolecualr ChemistryMolecular machines: Delving into the world of Supramolecualr Chemistry
Molecular machines: Delving into the world of Supramolecualr ChemistryShreesha Bhat
 
Polymer Nanocomposite
Polymer NanocompositePolymer Nanocomposite
Polymer Nanocompositekrishslide
 
Introduction to density functional theory
Introduction to density functional theory Introduction to density functional theory
Introduction to density functional theory Sarthak Hajirnis
 
Methods, tools, and examples (Part II): High-throughput computation and machi...
Methods, tools, and examples (Part II): High-throughput computation and machi...Methods, tools, and examples (Part II): High-throughput computation and machi...
Methods, tools, and examples (Part II): High-throughput computation and machi...Anubhav Jain
 
Organic Solar Cell
Organic Solar CellOrganic Solar Cell
Organic Solar CellAbhas Dash
 
Application of Nanotechnologies in the Energy Sector
Application of Nanotechnologies in the Energy SectorApplication of Nanotechnologies in the Energy Sector
Application of Nanotechnologies in the Energy SectorBasiony Shehata
 
Spin valve transistor
Spin valve transistorSpin valve transistor
Spin valve transistorEeshan Mishra
 
Dr. Jason Valentine-Metamaterials 2017
Dr. Jason Valentine-Metamaterials 2017Dr. Jason Valentine-Metamaterials 2017
Dr. Jason Valentine-Metamaterials 2017Vetrea Ruffin
 

Mais procurados (20)

Hartree fock theory
Hartree fock theoryHartree fock theory
Hartree fock theory
 
Density Functional Theory
Density Functional TheoryDensity Functional Theory
Density Functional Theory
 
Graphs, Environments, and Machine Learning for Materials Science
Graphs, Environments, and Machine Learning for Materials ScienceGraphs, Environments, and Machine Learning for Materials Science
Graphs, Environments, and Machine Learning for Materials Science
 
Introduction to DFT Part 1
Introduction to DFT Part 1 Introduction to DFT Part 1
Introduction to DFT Part 1
 
Neurosynaptic chips
Neurosynaptic chipsNeurosynaptic chips
Neurosynaptic chips
 
Nanotechnology in Defence Sector
Nanotechnology in Defence SectorNanotechnology in Defence Sector
Nanotechnology in Defence Sector
 
Nanoparticle Drug Delivery Systems for Cancer Treatment
Nanoparticle Drug Delivery Systems for Cancer TreatmentNanoparticle Drug Delivery Systems for Cancer Treatment
Nanoparticle Drug Delivery Systems for Cancer Treatment
 
Nano in defence
Nano in defenceNano in defence
Nano in defence
 
BIOS 203 Lecture 4: Ab initio molecular dynamics
BIOS 203 Lecture 4: Ab initio molecular dynamicsBIOS 203 Lecture 4: Ab initio molecular dynamics
BIOS 203 Lecture 4: Ab initio molecular dynamics
 
Nanotechnology: Basic introduction to the nanotechnology.
Nanotechnology: Basic introduction to the nanotechnology.Nanotechnology: Basic introduction to the nanotechnology.
Nanotechnology: Basic introduction to the nanotechnology.
 
Machine Learning for Chemical Sciences
Machine Learning for Chemical SciencesMachine Learning for Chemical Sciences
Machine Learning for Chemical Sciences
 
Quantum dots ppt
Quantum dots ppt Quantum dots ppt
Quantum dots ppt
 
Molecular machines: Delving into the world of Supramolecualr Chemistry
Molecular machines: Delving into the world of Supramolecualr ChemistryMolecular machines: Delving into the world of Supramolecualr Chemistry
Molecular machines: Delving into the world of Supramolecualr Chemistry
 
Polymer Nanocomposite
Polymer NanocompositePolymer Nanocomposite
Polymer Nanocomposite
 
Introduction to density functional theory
Introduction to density functional theory Introduction to density functional theory
Introduction to density functional theory
 
Methods, tools, and examples (Part II): High-throughput computation and machi...
Methods, tools, and examples (Part II): High-throughput computation and machi...Methods, tools, and examples (Part II): High-throughput computation and machi...
Methods, tools, and examples (Part II): High-throughput computation and machi...
 
Organic Solar Cell
Organic Solar CellOrganic Solar Cell
Organic Solar Cell
 
Application of Nanotechnologies in the Energy Sector
Application of Nanotechnologies in the Energy SectorApplication of Nanotechnologies in the Energy Sector
Application of Nanotechnologies in the Energy Sector
 
Spin valve transistor
Spin valve transistorSpin valve transistor
Spin valve transistor
 
Dr. Jason Valentine-Metamaterials 2017
Dr. Jason Valentine-Metamaterials 2017Dr. Jason Valentine-Metamaterials 2017
Dr. Jason Valentine-Metamaterials 2017
 

Semelhante a Implementing a neural network potential for exascale molecular dynamics

NS-CUK Seminar: S.T.Nguyen, Review on "Do We Really Need Complicated Model Ar...
NS-CUK Seminar: S.T.Nguyen, Review on "Do We Really Need Complicated Model Ar...NS-CUK Seminar: S.T.Nguyen, Review on "Do We Really Need Complicated Model Ar...
NS-CUK Seminar: S.T.Nguyen, Review on "Do We Really Need Complicated Model Ar...ssuser4b1f48
 
Large Scale Kernel Learning using Block Coordinate Descent
Large Scale Kernel Learning using Block Coordinate DescentLarge Scale Kernel Learning using Block Coordinate Descent
Large Scale Kernel Learning using Block Coordinate DescentShaleen Kumar Gupta
 
Graphical Structure Learning accelerated with POWER9
Graphical Structure Learning accelerated with POWER9Graphical Structure Learning accelerated with POWER9
Graphical Structure Learning accelerated with POWER9Ganesan Narayanasamy
 
Artificial Intelligence Applications in Petroleum Engineering - Part I
Artificial Intelligence Applications in Petroleum Engineering - Part IArtificial Intelligence Applications in Petroleum Engineering - Part I
Artificial Intelligence Applications in Petroleum Engineering - Part IRamez Abdalla, M.Sc
 
NS-CUK Seminar: V.T.Hoang, Review on "Relative Molecule Self-Attention Transf...
NS-CUK Seminar: V.T.Hoang, Review on "Relative Molecule Self-Attention Transf...NS-CUK Seminar: V.T.Hoang, Review on "Relative Molecule Self-Attention Transf...
NS-CUK Seminar: V.T.Hoang, Review on "Relative Molecule Self-Attention Transf...ssuser4b1f48
 
Implementation of energy efficient coverage aware routing protocol for wirele...
Implementation of energy efficient coverage aware routing protocol for wirele...Implementation of energy efficient coverage aware routing protocol for wirele...
Implementation of energy efficient coverage aware routing protocol for wirele...ijfcstjournal
 
Hidden Layer Leraning Vector Quantizatio
Hidden Layer Leraning Vector Quantizatio Hidden Layer Leraning Vector Quantizatio
Hidden Layer Leraning Vector Quantizatio Armando Vieira
 
Solar power forecasting report
Solar power forecasting reportSolar power forecasting report
Solar power forecasting reportGaurav Singh
 
APPLICATION OF GENETIC ALGORITHM IN DESIGNING A SECURITY MODEL FOR MOBILE ADH...
APPLICATION OF GENETIC ALGORITHM IN DESIGNING A SECURITY MODEL FOR MOBILE ADH...APPLICATION OF GENETIC ALGORITHM IN DESIGNING A SECURITY MODEL FOR MOBILE ADH...
APPLICATION OF GENETIC ALGORITHM IN DESIGNING A SECURITY MODEL FOR MOBILE ADH...cscpconf
 
Energy aware clustering protocol (eacp)
Energy aware clustering protocol (eacp)Energy aware clustering protocol (eacp)
Energy aware clustering protocol (eacp)IJCNCJournal
 
Data clustering using kernel based
Data clustering using kernel basedData clustering using kernel based
Data clustering using kernel basedIJITCA Journal
 
IJCER (www.ijceronline.com) International Journal of computational Engineerin...
IJCER (www.ijceronline.com) International Journal of computational Engineerin...IJCER (www.ijceronline.com) International Journal of computational Engineerin...
IJCER (www.ijceronline.com) International Journal of computational Engineerin...ijceronline
 
SCALING THE HTM SPATIAL POOLER
SCALING THE HTM SPATIAL POOLERSCALING THE HTM SPATIAL POOLER
SCALING THE HTM SPATIAL POOLERijaia
 
Energy efficient communication techniques for wireless micro sensor networks
Energy efficient communication techniques for wireless micro sensor networksEnergy efficient communication techniques for wireless micro sensor networks
Energy efficient communication techniques for wireless micro sensor networksPushpita Biswas
 

Semelhante a Implementing a neural network potential for exascale molecular dynamics (20)

NS-CUK Seminar: S.T.Nguyen, Review on "Do We Really Need Complicated Model Ar...
NS-CUK Seminar: S.T.Nguyen, Review on "Do We Really Need Complicated Model Ar...NS-CUK Seminar: S.T.Nguyen, Review on "Do We Really Need Complicated Model Ar...
NS-CUK Seminar: S.T.Nguyen, Review on "Do We Really Need Complicated Model Ar...
 
Large Scale Kernel Learning using Block Coordinate Descent
Large Scale Kernel Learning using Block Coordinate DescentLarge Scale Kernel Learning using Block Coordinate Descent
Large Scale Kernel Learning using Block Coordinate Descent
 
Brochure ADF Modeling Suite 2016
Brochure ADF Modeling Suite 2016Brochure ADF Modeling Suite 2016
Brochure ADF Modeling Suite 2016
 
cug2011-praveen
cug2011-praveencug2011-praveen
cug2011-praveen
 
Graphical Structure Learning accelerated with POWER9
Graphical Structure Learning accelerated with POWER9Graphical Structure Learning accelerated with POWER9
Graphical Structure Learning accelerated with POWER9
 
Artificial Intelligence Applications in Petroleum Engineering - Part I
Artificial Intelligence Applications in Petroleum Engineering - Part IArtificial Intelligence Applications in Petroleum Engineering - Part I
Artificial Intelligence Applications in Petroleum Engineering - Part I
 
D028018022
D028018022D028018022
D028018022
 
E04423133
E04423133E04423133
E04423133
 
NS-CUK Seminar: V.T.Hoang, Review on "Relative Molecule Self-Attention Transf...
NS-CUK Seminar: V.T.Hoang, Review on "Relative Molecule Self-Attention Transf...NS-CUK Seminar: V.T.Hoang, Review on "Relative Molecule Self-Attention Transf...
NS-CUK Seminar: V.T.Hoang, Review on "Relative Molecule Self-Attention Transf...
 
Implementation of energy efficient coverage aware routing protocol for wirele...
Implementation of energy efficient coverage aware routing protocol for wirele...Implementation of energy efficient coverage aware routing protocol for wirele...
Implementation of energy efficient coverage aware routing protocol for wirele...
 
Hidden Layer Leraning Vector Quantizatio
Hidden Layer Leraning Vector Quantizatio Hidden Layer Leraning Vector Quantizatio
Hidden Layer Leraning Vector Quantizatio
 
Solar power forecasting report
Solar power forecasting reportSolar power forecasting report
Solar power forecasting report
 
APPLICATION OF GENETIC ALGORITHM IN DESIGNING A SECURITY MODEL FOR MOBILE ADH...
APPLICATION OF GENETIC ALGORITHM IN DESIGNING A SECURITY MODEL FOR MOBILE ADH...APPLICATION OF GENETIC ALGORITHM IN DESIGNING A SECURITY MODEL FOR MOBILE ADH...
APPLICATION OF GENETIC ALGORITHM IN DESIGNING A SECURITY MODEL FOR MOBILE ADH...
 
Energy aware clustering protocol (eacp)
Energy aware clustering protocol (eacp)Energy aware clustering protocol (eacp)
Energy aware clustering protocol (eacp)
 
PPT
PPTPPT
PPT
 
Data clustering using kernel based
Data clustering using kernel basedData clustering using kernel based
Data clustering using kernel based
 
EiB Seminar from Esteban Vegas, Ph.D.
EiB Seminar from Esteban Vegas, Ph.D. EiB Seminar from Esteban Vegas, Ph.D.
EiB Seminar from Esteban Vegas, Ph.D.
 
IJCER (www.ijceronline.com) International Journal of computational Engineerin...
IJCER (www.ijceronline.com) International Journal of computational Engineerin...IJCER (www.ijceronline.com) International Journal of computational Engineerin...
IJCER (www.ijceronline.com) International Journal of computational Engineerin...
 
SCALING THE HTM SPATIAL POOLER
SCALING THE HTM SPATIAL POOLERSCALING THE HTM SPATIAL POOLER
SCALING THE HTM SPATIAL POOLER
 
Energy efficient communication techniques for wireless micro sensor networks
Energy efficient communication techniques for wireless micro sensor networksEnergy efficient communication techniques for wireless micro sensor networks
Energy efficient communication techniques for wireless micro sensor networks
 

Mais de PFHub PFHub

C hi mad_phasefieldworkshop(1)
C hi mad_phasefieldworkshop(1)C hi mad_phasefieldworkshop(1)
C hi mad_phasefieldworkshop(1)PFHub PFHub
 
AI for Science Grand Challenges
AI for Science Grand ChallengesAI for Science Grand Challenges
AI for Science Grand ChallengesPFHub PFHub
 
Cobalt-based Superalloys Development in CHiMaD
Cobalt-based Superalloys Development in CHiMaDCobalt-based Superalloys Development in CHiMaD
Cobalt-based Superalloys Development in CHiMaDPFHub PFHub
 
Microstructural Analysis and Machine Learning
Microstructural Analysis and Machine LearningMicrostructural Analysis and Machine Learning
Microstructural Analysis and Machine LearningPFHub PFHub
 
Using phase field simulations to assist with experiments and experimental data
Using phase field simulations to assist with experiments and experimental dataUsing phase field simulations to assist with experiments and experimental data
Using phase field simulations to assist with experiments and experimental dataPFHub PFHub
 
Uncertainty Propagation in CALPHAD-reinforced Elastochemical Phase-field Mode...
Uncertainty Propagation in CALPHAD-reinforced Elastochemical Phase-field Mode...Uncertainty Propagation in CALPHAD-reinforced Elastochemical Phase-field Mode...
Uncertainty Propagation in CALPHAD-reinforced Elastochemical Phase-field Mode...PFHub PFHub
 
UNCERTAINTY QUANTIFICATION OF PHASE EQUILIBRIA AND THERMODYNAMICS
UNCERTAINTY QUANTIFICATION OF PHASE EQUILIBRIA AND THERMODYNAMICSUNCERTAINTY QUANTIFICATION OF PHASE EQUILIBRIA AND THERMODYNAMICS
UNCERTAINTY QUANTIFICATION OF PHASE EQUILIBRIA AND THERMODYNAMICSPFHub PFHub
 
Community-Driven Benchmark Problems for Phase Field Modeling
Community-Driven Benchmark Problems for Phase Field ModelingCommunity-Driven Benchmark Problems for Phase Field Modeling
Community-Driven Benchmark Problems for Phase Field ModelingPFHub PFHub
 
The Phase Field Method: Mesoscale Simulation Aiding Materials Discovery
The Phase Field Method: Mesoscale Simulation Aiding Materials DiscoveryThe Phase Field Method: Mesoscale Simulation Aiding Materials Discovery
The Phase Field Method: Mesoscale Simulation Aiding Materials DiscoveryPFHub PFHub
 
Phase-field modeling of crystal nucleation: Comparison with simulations and e...
Phase-field modeling of crystal nucleation: Comparison with simulations and e...Phase-field modeling of crystal nucleation: Comparison with simulations and e...
Phase-field modeling of crystal nucleation: Comparison with simulations and e...PFHub PFHub
 
Nucleation III: Phase-field crystal modeling of nucleation process
Nucleation III: Phase-field crystal modeling of nucleation processNucleation III: Phase-field crystal modeling of nucleation process
Nucleation III: Phase-field crystal modeling of nucleation processPFHub PFHub
 
Using an Explicit Nucleation Model in PRISIMS-PF to Predict Precipate Microst...
Using an Explicit Nucleation Model in PRISIMS-PF to Predict Precipate Microst...Using an Explicit Nucleation Model in PRISIMS-PF to Predict Precipate Microst...
Using an Explicit Nucleation Model in PRISIMS-PF to Predict Precipate Microst...PFHub PFHub
 
Phase-field modeling of crystal nucleation I: Fundamentals and methods
Phase-field modeling of crystal nucleation I: Fundamentals and methodsPhase-field modeling of crystal nucleation I: Fundamentals and methods
Phase-field modeling of crystal nucleation I: Fundamentals and methodsPFHub PFHub
 
Benchmark 6 Update
Benchmark 6 UpdateBenchmark 6 Update
Benchmark 6 UpdatePFHub PFHub
 
Educating Researchers Using the CHiMaD Benchmark Problems
Educating Researchers Using the CHiMaD Benchmark ProblemsEducating Researchers Using the CHiMaD Benchmark Problems
Educating Researchers Using the CHiMaD Benchmark ProblemsPFHub PFHub
 
Multi-phase-field simulations with OpenPhase
Multi-phase-field simulations with OpenPhaseMulti-phase-field simulations with OpenPhase
Multi-phase-field simulations with OpenPhasePFHub PFHub
 
Phase-field modeling of crystal nucleation II: Comparison with simulations an...
Phase-field modeling of crystal nucleation II: Comparison with simulations an...Phase-field modeling of crystal nucleation II: Comparison with simulations an...
Phase-field modeling of crystal nucleation II: Comparison with simulations an...PFHub PFHub
 
Update on Benchmark 7
Update on Benchmark 7Update on Benchmark 7
Update on Benchmark 7PFHub PFHub
 
Theoretical and Applied Phase-Field: Glimpses of the activities in India
Theoretical and Applied Phase-Field: Glimpses of the activities in IndiaTheoretical and Applied Phase-Field: Glimpses of the activities in India
Theoretical and Applied Phase-Field: Glimpses of the activities in IndiaPFHub PFHub
 

Mais de PFHub PFHub (20)

Pf
PfPf
Pf
 
C hi mad_phasefieldworkshop(1)
C hi mad_phasefieldworkshop(1)C hi mad_phasefieldworkshop(1)
C hi mad_phasefieldworkshop(1)
 
AI for Science Grand Challenges
AI for Science Grand ChallengesAI for Science Grand Challenges
AI for Science Grand Challenges
 
Cobalt-based Superalloys Development in CHiMaD
Cobalt-based Superalloys Development in CHiMaDCobalt-based Superalloys Development in CHiMaD
Cobalt-based Superalloys Development in CHiMaD
 
Microstructural Analysis and Machine Learning
Microstructural Analysis and Machine LearningMicrostructural Analysis and Machine Learning
Microstructural Analysis and Machine Learning
 
Using phase field simulations to assist with experiments and experimental data
Using phase field simulations to assist with experiments and experimental dataUsing phase field simulations to assist with experiments and experimental data
Using phase field simulations to assist with experiments and experimental data
 
Uncertainty Propagation in CALPHAD-reinforced Elastochemical Phase-field Mode...
Uncertainty Propagation in CALPHAD-reinforced Elastochemical Phase-field Mode...Uncertainty Propagation in CALPHAD-reinforced Elastochemical Phase-field Mode...
Uncertainty Propagation in CALPHAD-reinforced Elastochemical Phase-field Mode...
 
UNCERTAINTY QUANTIFICATION OF PHASE EQUILIBRIA AND THERMODYNAMICS
UNCERTAINTY QUANTIFICATION OF PHASE EQUILIBRIA AND THERMODYNAMICSUNCERTAINTY QUANTIFICATION OF PHASE EQUILIBRIA AND THERMODYNAMICS
UNCERTAINTY QUANTIFICATION OF PHASE EQUILIBRIA AND THERMODYNAMICS
 
Community-Driven Benchmark Problems for Phase Field Modeling
Community-Driven Benchmark Problems for Phase Field ModelingCommunity-Driven Benchmark Problems for Phase Field Modeling
Community-Driven Benchmark Problems for Phase Field Modeling
 
The Phase Field Method: Mesoscale Simulation Aiding Materials Discovery
The Phase Field Method: Mesoscale Simulation Aiding Materials DiscoveryThe Phase Field Method: Mesoscale Simulation Aiding Materials Discovery
The Phase Field Method: Mesoscale Simulation Aiding Materials Discovery
 
Phase-field modeling of crystal nucleation: Comparison with simulations and e...
Phase-field modeling of crystal nucleation: Comparison with simulations and e...Phase-field modeling of crystal nucleation: Comparison with simulations and e...
Phase-field modeling of crystal nucleation: Comparison with simulations and e...
 
Nucleation III: Phase-field crystal modeling of nucleation process
Nucleation III: Phase-field crystal modeling of nucleation processNucleation III: Phase-field crystal modeling of nucleation process
Nucleation III: Phase-field crystal modeling of nucleation process
 
Using an Explicit Nucleation Model in PRISIMS-PF to Predict Precipate Microst...
Using an Explicit Nucleation Model in PRISIMS-PF to Predict Precipate Microst...Using an Explicit Nucleation Model in PRISIMS-PF to Predict Precipate Microst...
Using an Explicit Nucleation Model in PRISIMS-PF to Predict Precipate Microst...
 
Phase-field modeling of crystal nucleation I: Fundamentals and methods
Phase-field modeling of crystal nucleation I: Fundamentals and methodsPhase-field modeling of crystal nucleation I: Fundamentals and methods
Phase-field modeling of crystal nucleation I: Fundamentals and methods
 
Benchmark 6 Update
Benchmark 6 UpdateBenchmark 6 Update
Benchmark 6 Update
 
Educating Researchers Using the CHiMaD Benchmark Problems
Educating Researchers Using the CHiMaD Benchmark ProblemsEducating Researchers Using the CHiMaD Benchmark Problems
Educating Researchers Using the CHiMaD Benchmark Problems
 
Multi-phase-field simulations with OpenPhase
Multi-phase-field simulations with OpenPhaseMulti-phase-field simulations with OpenPhase
Multi-phase-field simulations with OpenPhase
 
Phase-field modeling of crystal nucleation II: Comparison with simulations an...
Phase-field modeling of crystal nucleation II: Comparison with simulations an...Phase-field modeling of crystal nucleation II: Comparison with simulations an...
Phase-field modeling of crystal nucleation II: Comparison with simulations an...
 
Update on Benchmark 7
Update on Benchmark 7Update on Benchmark 7
Update on Benchmark 7
 
Theoretical and Applied Phase-Field: Glimpses of the activities in India
Theoretical and Applied Phase-Field: Glimpses of the activities in IndiaTheoretical and Applied Phase-Field: Glimpses of the activities in India
Theoretical and Applied Phase-Field: Glimpses of the activities in India
 

Último

SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxkessiyaTpeter
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTSérgio Sacani
 
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...Sérgio Sacani
 
Zoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfZoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfSumit Kumar yadav
 
Animal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptxAnimal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptxUmerFayaz5
 
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptxUnlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptxanandsmhk
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)Areesha Ahmad
 
Pests of cotton_Sucking_Pests_Dr.UPR.pdf
Pests of cotton_Sucking_Pests_Dr.UPR.pdfPests of cotton_Sucking_Pests_Dr.UPR.pdf
Pests of cotton_Sucking_Pests_Dr.UPR.pdfPirithiRaju
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsSumit Kumar yadav
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)PraveenaKalaiselvan1
 
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...jana861314
 
Chemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdfChemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdfSumit Kumar yadav
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsAArockiyaNisha
 
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Sérgio Sacani
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxgindu3009
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxjana861314
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisDiwakar Mishra
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​kaibalyasahoo82800
 

Último (20)

SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOST
 
CELL -Structural and Functional unit of life.pdf
CELL -Structural and Functional unit of life.pdfCELL -Structural and Functional unit of life.pdf
CELL -Structural and Functional unit of life.pdf
 
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
 
Zoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfZoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdf
 
Animal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptxAnimal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptx
 
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptxUnlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)
 
Pests of cotton_Sucking_Pests_Dr.UPR.pdf
Pests of cotton_Sucking_Pests_Dr.UPR.pdfPests of cotton_Sucking_Pests_Dr.UPR.pdf
Pests of cotton_Sucking_Pests_Dr.UPR.pdf
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questions
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)
 
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
 
Chemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdfChemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdf
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based Nanomaterials
 
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptx
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
 
Engler and Prantl system of classification in plant taxonomy
Engler and Prantl system of classification in plant taxonomyEngler and Prantl system of classification in plant taxonomy
Engler and Prantl system of classification in plant taxonomy
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​
 

Implementing a neural network potential for exascale molecular dynamics

  • 1. Implementing a neural network potential for exascale molecular dynamics Saaketh Desai, Sam Reeve, Jim Belak Lawrence Livermore National Laboratory School of Materials Engineering, Purdue University Computational Chemistry and Materials Science (CCMS) Summer Institute 2019
  • 2. 2 Molecular dynamics and machine-learned potentials Obtain updated positions and velocities Start with a set of positions and velocities Solve F = ma Verlet integration Define atomic interactions (interatomic potential) Lennard-Jones Ø DFT ~ O(n3 e) Ø Interatomic potential ~ O(natoms) Ø Can we get quantum mechanical accuracy with linear scaling? 𝐸𝑖 = 𝜖 𝑐𝐹 𝛼 ( )*+ 𝜌 𝛽 𝑟𝑖𝑗 + 1 2 ( )*+ 𝜙 𝛼𝛽 𝑟𝑖𝑗 Embedded Atom Model Spectral Neighbor Analysis Potential
  • 3. 3 Caution: more than blind ab-initio sim (cf: yesterday) Can ML be used to identify where new data is needed? How do we decide if a funny feature is real or an artifact?
  • 4. 4 Descriptor-based machine-learned potentials Descriptor Symmetry Functions SOAP Bispectrum coefficients ML method Neural network Gaussian Process Linear Regression Atomic structure GAP SNAP NNP MTP qSNAP Figure from arXiv:1906.08888 [physics.comp-ph] EAM MEAM Ø Can we improve implementation to break the pareto front?
  • 5. 5 A closer look at the kernel traditional 𝑉 𝑟+) = 5 678 9: − 5 678 < 𝐹𝑜𝑟 𝑎𝑡𝑜𝑚 𝑖 = 1: 𝑁 𝐹𝑜𝑟 𝑒𝑎𝑐ℎ 𝑛𝑒𝑖𝑔ℎ𝑏𝑜𝑟 𝑗 𝑜𝑓 𝑎𝑡𝑜𝑚 𝑖 unique 𝐸IJIKLM = ( + 𝐸+ 𝑓+ N = ( ) * + ( O 𝜕𝐸) 𝜕𝐺),O ∗ 𝜕𝐺),O 𝜕𝑟+) N 𝐺O 𝑟+) = 𝑒 TUV 678 T6WV X 𝑓Y(𝑟+)) 𝐹𝑜𝑟 𝑒𝑎𝑐ℎ 𝑑𝑒𝑠𝑐𝑟𝑖𝑝𝑡𝑜𝑟 𝑘 𝐸+ = 𝑁𝑁 (𝐺+) 𝐹𝑜𝑟 𝑎𝑡𝑜𝑚 𝑖 = 1: 𝑁 𝐹𝑜𝑟 𝑎𝑡𝑜𝑚 𝑖 = 1: 𝑁 1 G1k G1j G2j G2k atom i neighbor j neighbor k G1(r) G2(r) G3(r) G4(r) G1(atom i) = G1j + G1k G2(atom i) = G2j + G2k 2 3 ~30 2
  • 6. 6 Other neural network potentials Weinan E. et. al., Computer Physics Communications 228 (2018) Schütt, Kristof, et al. Advances in Neural Information Processing Systems. 2017 GAP SNAPHDNNP SchNet DeepMD 2007 2010 2015 2017 2018 2019 SimpleNN wACSF HIP-NN, AIMNet ANI-1Ø Suggested improvements to HDNNPs Ø Machine – learned descriptors vs handcrafted descriptors? SchNet DeepMD
  • 7. 7 Implementation details Singraber, Andreas, Jörg Behler, and Christoph Dellago, Journal of chemical theory and computation 15.3 (2019): 1827-1840. https://github.com/CompPhysVienna/n2p2 Ø Evaluate scaling performance on water Ø Compare with other potentials published in arXiv:1906.08888 [physics.comp-ph] n2p2 – LAMMPS CabanaMD Memory based model (large structs) Cabana AoSoAs/ Kokkos views Minor explicit OpenMP parallelization Kokkos and Cabana parallelization Ø Easy to read and modify C++ code Ø Stand-alone package with no dependencies (Tensorflow etc) Ø Neural network potential closest to traditional interatomic potentials Why choose n2p2? How to implement performance portable version of n2p2?
  • 8. 8 Performance gains by re-implementation 8K atoms 36K atoms 121K atoms saturating performance memory-bound (small systems) Ø Our implementation scales better, allowing large system sizes Ø GPU implementation shows significant improvement Ø Intel Broadwell node / Nvidia V100 GPU n2p2 (LAMMPS) increasing performance n2p2 (LAMMPS) CPU GPU CabanaMD scales well worker-bound 8K atoms 36K atoms CabanaMD 121K atoms 562K atoms 1.5M atoms 4.5M atoms 8K atoms 36K atoms 121K atoms saturating performance memory-bound (small systems) n2p2 (LAMMPS) increasing performance
  • 9. 9 Performance across various systems GPU – H2O GPU – Ni Ni (~1.5M) H2O (~36K) strong scaling weak scaling Ni (~40k per thread) Ø Ni potential shows vastly superior performance to H2O (CPU and GPU) Ø Strong scaling shows parallel efficiency of around 75% Ø MPI scaling results coming soon…
  • 10. 10 Data layout for better performance Ø Neural network still a minor part of computation Ø Splitting 6 AoSoAs and changing vector lengths show minor improvements on the GPU Ø Hierarchical parallelism shows promise, subject to further testing Ni (CPU)01 08 16 32 01 08 16 32 ForcesNeural network Symmetry Functions 01 08 1632 01 08 16 32Ni (GPU)
  • 11. Ø We implemented a neural network potential in CabanaMD using Kokkos/Cabana constructs Ø Kokkos/Cabana based implementation of neural network potential offers significant on-node scalability (~4x speedup and 10x larger systems) Ø First – ever GPU implementation of neural network potential shows up to 10x improvement over CPU implementation (single element performance ~ 1 million atomsteps per second) Ø Data layout changes offer additional ~10% performance gain Summary and future work
  • 13. • CALPHAD uses a power series expansion in temperature, pressure and constitution • By analogy to ML potentials, can ML be used to construct free energies? • Can ML augment CALPHAD and reveal features not possible from an analytic fit? • Are there correlations in multi-component systems revealed using ML? (not possible using analytic models) • Can ML be used to identify missing data and/or extend the thermodynamic data used in CALPHAD assessments? • How does one maintain thermodynamic consistency using ML? • What about non-equilibrium free energies? • What about transition / mixed regions (values of phi between 0 and 1)? 13 CALPHAD / PT is the low hanging fruit
  • 14. • Liz Holm use machine vision in 2D, Peter’s students are doing this in 3D. • Can ML classify unique microstructures? (yes) • Can ML be used to quantify the “distance” between microstructure? How close are two microstructures? Statistically? • We want to quantitatively compare simulated microstructure to experimental observation. 14 Classify Microstructures (CNN) 132 B.L. DeCost, E.A. Holm / Computational Materials Science 110 (2015) 126–133 DeCost and Holm, Comp. Mat. Sci. 110 (2015) 126-133
  • 15. • Billion atom simulations of nucleation / solidification are becoming routine (Shibuta, Nature Comm 2017) • Can ML by used to determine the best model from simulation or experimental data? • Or create an ML model that uses a know free energy? Generative Model. 15 Model determination (Supervised and GANs) • Low fruit is determining optimal model parameters (e.g. mobilities) • Can PFM datasets in a similar ML framework be used to determine microstructure aware continuum models? • Nucleation: Can ML be used to detect anomalies in PF simulations? • Can ML be used to control / steer simulations? Drive design of experiments (cf. Michael Tonks)? • Is there an analogy to putting smart sensors into the simulation?