SlideShare une entreprise Scribd logo
1  sur  110
Télécharger pour lire hors ligne
̂HΨ = EΨ
̂HΨ(r1, ⋯, rN) = EΨ(r1, ⋯, rN)
̂H
Ψ E
̂H = −
ℏ2
2me
∇2
1 −
ℏ2
2me
∇2
2 −
e2
4πϵ0 (
1
ra1
+
1
rb1
+
1
ra2
+
1
rb2 )
+
e2
4πϵ0
1
r12
+
e2
4πϵ0R
Ψ(x1, y1, z1, x2, y2, z2)
̂Hx = λx
N 1 N − 1 N − 1
3N 3 N
|⟨ΨfullCI |ΨHartree−Fock⟩|2
≈ 1
1
3N
N
|Ψ0⟩ {χa}i=1,⋯,r
Ψ0⟩ = χ1χ2⋯χa χb⋯χN⟩
E0 = ⟨Ψ0 | ̂ℋ|Ψ0⟩ =
∑
a
⟨a|h|a⟩ +
1
2 ∑
ab
⟨ab||ab⟩
⟨χa |χb⟩ = δab
[
h(1) +
N
∑
b=1
𝒥b(1) − 𝒦b(1)
]
χa(1) =
N
∑
b=1
εba χb(1)
f χa⟩ =
N
∑
b=1
εba xb⟩
f χa⟩ = εa χa⟩
{ϕμ}
ψi =
K
∑
μ=1
Cμiϕμ
Sμv =
∫
dr1ϕ*μ (1)ϕv(1)
Fμv =
∫
dr1ϕ*μ (1)f(1)ϕv(1)
∑
v
FμvCvi = εi ∑
v
SμvCvi FC = SCε
FC = SCε
Fμv = Hcore
μv +
∑
a
∑
λσ
CλaC*σa[2(μv|σλ) − (μλ|σv)]
$ sudo apt install psi4 python3-numpy libopenblas-dev
…
#! STO-3G H2 Hartree-Fock Energy Point
# see also: http://pubchemqc.riken.jp/cgi-bin/molecularquery.py?name=hydrogen
molecule h2 {
H 0.0 0.0 0.0
H 0.0 0.0 1.4
unit bohr
}
set {
basis STO-3G
}
thisenergy = energy('hf')
#! STO-3G H2 Hartree-Fock Energy Point
# see also: http://pubchemqc.riken.jp/cgi-bin/molecularquery.py?name=hydrogen
molecule h2 {
H 0.0 0.0 0.0
H 0.0 0.0 1.4
unit bohr
}
set {
basis STO-3G
}
thisenergy = energy('hf')
****
H 0
S 3 1.00
3.42525091 0.15432897
0.62391373 0.53532814
0.16885540 0.44463454
en, wfn = energy('hf', return_wfn=True)
nbf = wfn.nso()
mints = psi4.core.MintsHelper(wfn.basisset())
S = np.asarray(mints.ao_overlap())
for i in range(nbf):
for j in range(nbf):
print (i+1,j+1, S[i,j])
(μv|λσ)
|Ψ0⟩
{χa}i=1,⋯,r
|Ψ0⟩ = |χ1χ2⋯χa χb⋯χN⟩
{χa}i=1,⋯,r
|Ψ0⟩
|Ψ⟩ = c0 |Φ0⟩ +
occ
∑
i
vir
∑
a
ca
i |Φa
i ⟩ +
occ
∑
i<j
vir
∑
a<b
cab
ij |Φab
ij ⟩ +
occ
∑
i<j<k
vir
∑
a<b<c
cabc
ijk |Φabc
ijk ⟩ + ⋯
|Φ0⟩
|Φ0⟩ = |χ1χ2⋯χa χb⋯χN⟩
|Φa
i ⟩
|Φa
i ⟩ = |χ1χ2⋯χi−1χa χi+1⋯χN⟩
|Φab
ij ⟩
|Φab
ij ⟩ = |χ1χ2⋯χi−1χa χi+1⋯χj−1χb χj+1⋯χN⟩
ca
i , cab
ij
|Ψ⟩ = c0 |Φ0⟩ +
occ
∑
i
vir
∑
a
ca
i |Φa
i ⟩ +
occ
∑
i<j
vir
∑
a<b
cab
ij |Φab
ij ⟩ +
occ
∑
i<j<k
vir
∑
a<b<c
cabc
ijk |Φabc
ijk ⟩ + ⋯
min
⟨Ψ|Ψ⟩=1
⟨Ψ| ̂H|Ψ⟩
rCN
#! STO-3G H2 FullCI Energy Point
# see also: http://pubchemqc.riken.jp/cgi-bin/molecularquery.py?name=hydrogen
molecule h2 {
H 0.0 0.0 0.0
H 0.0 0.0 1.4
unit bohr
}
set {
basis STO-3G
}
thisenergy = energy(‘fci')
|⟨ΨFullCI |ΦHF⟩|2
= − 0.9872
|Ψ⟩ = c0 |Φ0⟩ +
occ
∑
i
vir
∑
a
ca
i |Φa
i ⟩ +
occ
∑
i<j
vir
∑
a<b
cab
ij |Φab
ij ⟩ +
occ
∑
i<j<k
vir
∑
a<b<c
cabc
ijk |Φabc
ijk ⟩ + ⋯
|ΨfullCI⟩ = − 0.993627|ΦHF⟩ + 0.112716|Φ2¯2
1¯1
⟩
|⟨ΨFullCI |ΦHF⟩|2
= 0.9872
|⟨ΨFullCI |ΦHF⟩|2
r(H − H)
r(H − H)
|⟨ΨFullCI |ΦHF⟩|2
(7C5)2
= 21 * 21 = 441
: CCSD(T), MP2 14_n2_631g_cc_mp_pes.dat
N-N FullCI Hartree-Fock CCSD(T) MP2
fullCI (1.5A ?)
|⟨ΨfullCI |ΨHF⟩|2
|11⟩, |01⟩, |10⟩, |00⟩
|111⟩, |101⟩, |110⟩, |100⟩
|011⟩, |001⟩, |010⟩, |000⟩
|1⟩, |0⟩
|00000000⟩ + |00000001⟩ + . . . + |11111111⟩
ei ̂Ht
|ΦHF⟩ = c0eiE0t
|Ψ0⟩ + c1eiE1t
|Ψ1⟩ + c2eiE2t
|Ψ2⟩⋯
ei ̂Hτ
≈
∏
i
eHΔτi ≈
∏
i
e
∑j
HjΔτi
̂H|Ψ⟩ = E|Ψ⟩ → ei ̂Hτ
|Ψ⟩ = ̂U|Ψ⟩ = ei2πϕ
|Ψ⟩
ei2πϕ
|Ψ⟩ ⊗ |R⟩ → ei2πϕ
|Ψ⟩ ⊗ ei2πϕ
|R⟩ → measure|R⟩ → E = 2πϕ/τ
|⟨ΦFullCI |ΦHF⟩|2
≈ 1
E0 ≤ E1 ≤ E2 ≤ ⋯
$ dotnet new -i “Microsoft.Quantum.ProjectTemplates::0.7-*”
…
$ mkdir -p qsharp
$ cd qsharp
$ sudo apt install git
$ git clone https://github.com/Microsoft/Quantum.git
$ git clone https://github.com/microsoft/QuantumLibraries
|ψ⟩
CNOT(H ⊗ 1)|00⟩ ⟶
|00⟩ + |11⟩
2
|ψ⟩ = α|0⟩ + β|1⟩ |ψ⟩ ⊗
|00⟩ + |11⟩
2
(H ⊗ 1 ⊗ 1)[CNOT ⊗ 1]|ψ⟩ ⊗
|00⟩ + |11⟩
2
=
1
2
[α|000⟩ + α|100⟩ + α|011⟩ + α|111⟩ + β|010⟩ − β|110⟩ + β|001⟩ − β|101⟩]
1
2
[|00⟩(α|0⟩ + β|1⟩) + |01⟩(α|1⟩ + β|0⟩) + |10⟩(α|0⟩ − β|1⟩) + |11⟩(α|1⟩ − β|0⟩)]
$ cd Quantum/Samples/src/Teleportation
$ dotnet run
Round 0: Sent True, got True.
Teleportation successful!!
Round 1: Sent False, got False.
Teleportation successful!!
Round 2: Sent False, got False.
Teleportation successful!!
Round 3: Sent True, got True.
Teleportation successful!!
Round 4: Sent False, got False.
Teleportation successful!!
Round 5: Sent True, got True.
Teleportation successful!!
Round 6: Sent True, got True.
Teleportation successful!!
Round 7: Sent False, got False.
Teleportation successful!!
operation Teleport (msg : Qubit, target : Qubit) : Unit {
using (register = Qubit()) {
// Create some entanglement that we can use to send our message.
H(register);
CNOT(register, target);
// Encode the message into the entangled pair,
// and measure the qubits to extract the classical data
// we need to correctly decode the message into the target qubit:
CNOT(msg, register);
H(msg);
let data1 = M(msg);
let data2 = M(register);
// decode the message by applying the corrections on
// the target qubit accordingly:
if (data1 == One) { Z(target); }
if (data2 == One) { X(target); }
// Reset our "register" qubit before releasing it.
Reset(register);
}
}
// Copyright (c) Microsoft Corporation. All rights reserved.
// Licensed under the MIT License.
using Microsoft.Quantum.Simulation.Simulators;
using System.Linq;
namespace Microsoft.Quantum.Samples.Teleportation {
class Program
{
static void Main(string[] args)
{
using (var sim = new QuantumSimulator())
{
var rand = new System.Random();
foreach (var idxRun in Enumerable.Range(0, 8))
{
var sent = rand.Next(2) == 0;
var received = TeleportClassicalMessage.Run(sim, sent).Result;
System.Console.WriteLine($"Round {idxRun}:tSent {sent},tgot
{received}.");
System.Console.WriteLine(sent == received ? "Teleportation
successful!!n" : "n");
}
}
}
}
}
̂H =
∑
i,j
vija†
i
aj +
1
2 ∑
ijkl
wijkla†
i
a†
j
alak
|Ψ⟩
̂H|Ψ⟩ = E|Ψ⟩
|⟨ΦFullCI |ΦHF⟩|2
≈ 1
E0 ≤ E1 ≤ E2 ≤ ⋯
|Ψ⟩ = c0 |Φ0⟩ +
occ
∑
i
vir
∑
a
ca
i |Φa
i ⟩ +
occ
∑
i<j
vir
∑
a<b
cab
ij |Φab
ij ⟩ +
occ
∑
i<j<k
vir
∑
a<b<c
cabc
ijk |Φabc
ijk ⟩ + ⋯
|Φ0⟩ = |χ1χ2⋯χa χb⋯χN⟩
|Φa
i ⟩ = |χ1χ2⋯χi−1χa χi+1⋯χN⟩
|Φab
ij ⟩ = |χ1χ2⋯χi−1χa χi+1⋯χj−1χb χj+1⋯χN⟩
= |111111000000⟩
= |111110001000⟩
= |110110001010⟩
2r
r ≃ log(2r
)
1/ N!
̂P12Ψ(x1, x2) = ± Ψ(x1, x2)
̂H|Ψ⟩ = E|Ψ⟩ → ei ̂Hτ
|Ψ⟩ = ̂U|Ψ⟩ = ei2πϕ
|Ψ⟩
ei2πϕ
|Ψ⟩ ⊗ |R⟩ → ei2πϕ
|Ψ⟩ ⊗ ei2πϕ
|R⟩ → measure|R⟩ → E = 2πϕ/τ
̂H =
∑
i,j
vija†
i
aj +
1
2 ∑
ijkl
wijkla†
i
a†
j
alak
̂H =
∑
ijkl
Hijkla†
i
a†
j
alak
ei ̂Ht
|ΦHF⟩ = c0eiE0t
|Ψ0⟩ + c1eiE1t
|Ψ1⟩ + c2eiE2t
|Ψ2⟩⋯
exp(i ̂Ht)
Hijkla†
i
a†
j
alak
ei ̂Ht
≈
∏
Δt
eHΔt
≈
∏
Δt
e
∑ijkl
HijklΔt
≈
∏
Δt,ijkl
eHijklΔt
|000000111111 >
|⟨ΦFullCI |ΦHF⟩|2
≈ 1
E0 ≤ E1 ≤ E2 ≤ ⋯
ei ̂Ht
|ΦHF⟩ = c0eiE0t
|Ψ0⟩ + c1eiE1t
|Ψ1⟩ + c2eiE2t
|Ψ2⟩⋯
$ cd Quantum/Chemistry/MolecularHydrogen
$ dotnet run
----- Print Hamiltonian
PP has 4 entries).
[1 * 0u 0d, -1.252477495]
[1 * 1u 1d, -1.252477495]
[1 * 2u 2d, -0.475934275]
[1 * 3u 3d, -0.475934275]
PQQP has 6 entries).
[1 * 0u 1u 1d 0d, 0.674493166]
[1 * 0u 2u 2d 0d, 0.482184583]
[1 * 1u 3u 3d 1d, 0.482184583]
[1 * 1u 2u 2d 1d, 0.663472101]
[1 * 0u 3u 3d 0d, 0.663472101]
[1 * 2u 3u 3d 2d, 0.69739801]
PQRS has 2 entries).
[1 * 0u 3u 2d 1d, -0.362575036]
[1 * 0u 1u 3d 2d, 0.362575036]
Identity has 1 entries).
[1 * , 0.713776188]
----- End Print Hamiltonian
----- Creating Jordan–Wigner encoding
----- End Creating Jordan–Wigner encoding
----- Print Hamiltonian
Identity has 1 entries).
[Identity: [ ], -0.098834446]
Z has 4 entries).
[Z: [ 0 ], 0.171201285]
[Z: [ 1 ], 0.171201285]
[Z: [ 2 ], -0.222796536]
[Z: [ 3 ], -0.222796536]
ZZ has 6 entries).
[ZZ: [ 0 1 ], 0.1686232915]
[ZZ: [ 0 2 ], 0.12054614575]
[ZZ: [ 1 3 ], 0.12054614575]
[ZZ: [ 1 2 ], 0.16586802525]
[ZZ: [ 0 3 ], 0.16586802525]
[ZZ: [ 2 3 ], 0.1743495025]
v01234 has 1 entries).
[v01234: [ 0 1 2 3 ], 0, -0.0453218795, 0, 0.0453218795]
----- End Print Hamiltonian
$ psi4 07_h2_sto3g_hf_dumpint.dat
1 electron integral
1 1 -1.25247730398
2 2 -0.475934461144
2 electron integral
1 1 1 1 0.674493103326
1 2 1 2 0.181287535812
2 2 1 1 0.663472044861
2 2 2 2 0.69739794982
Exact molecular Hydrogen ground state energy: -1.137260278.
----- Performing quantum energy estimation by Trotter simulation algorithm
Rep #1/5: Energy estimate: -1.16005261648883; Phase estimate: -0.424487268195532
Rep #2/5: Energy estimate: -1.11126176600452; Phase estimate: -0.404970928001809
Rep #3/5: Energy estimate: -1.14194138176224; Phase estimate: -0.417242774304894
Rep #4/5: Energy estimate: -1.12383014703564; Phase estimate: -0.409998280414257
Rep #5/5: Energy estimate: -1.11126176600452; Phase estimate: -0.404970928001809
----- End Performing quantum energy estimation by Trotter simulation algorithm
----- Performing quantum energy estimation by Qubitization simulation algorithm
Rep #1/1: Energy estimate: -1.1347488350418; Phase estimate: -0.581804128657449
----- End Performing quantum energy estimation by Qubitization simulation algorithm
namespace Microsoft.Quantum.Chemistry.Samples.Hydrogen
{
class Program
{
static void Main(string[] args)
{
//////////////////////////////////////////////////////////////////////////
// Introduction //////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////////////
// In this example, we will create a spin-orbital representation of the molecular
// Hydrogen Hamiltonian `H`, given ovelap coefficients for its one- and
// two - electron integrals.
// We when perform quantum phase estimation to obtain an estimate of
// the molecular Hydrogen ground state energy.
#region Building the Hydrogen Hamiltonian through orbital integrals
// One of the simplest representations of Hydrogen uses only two
// molecular orbitals indexed by `0` and `1`.
var nOrbitals = 2;
// This representation also has two occupied spin-orbitals.
var nElectrons = 2;
// The Coulomb repulsion energy between nuclei is
var energyOffset = 0.713776188;
// One-electron integrals are listed below
// <0|H|0> = -1.252477495
// <1|H|1> = -0.475934275
// Two-electron integrals are listed below
// <00|H|00> = 0.674493166
// <01|H|01> = 0.181287518
// <01|H|10> = 0.663472101
// <11|H|11> = 0.697398010
•
$ psi4 07_h2_sto3g_hf_dumpint
1 electron integral
1 1 -1.25247730398
2 2 -0.475934461144
2 electron integral
1 1 1 1 0.674493103326
1 2 1 2 0.181287535812
2 2 1 1 0.663472044861
2 2 2 2 0.69739794982
// We initialize a fermion Hamiltonian data structure and add terms to it
var fermionHamiltonian = new
OrbitalIntegralHamiltonian(orbitalIntegrals).ToFermionHamiltonian();
// These orbital integral terms are automatically expanded into
// spin-orbitals. We may print the Hamiltonian to see verify what it contains.
Console.WriteLine("----- Print Hamiltonian");
Console.Write(fermionHamiltonian);
Console.WriteLine("----- End Print Hamiltonian n");
// We also need to create an input quantum state to this Hamiltonian.
// Let us use the Hartree–Fock state.
var fermionWavefunction = fermionHamiltonian.CreateHartreeFockState(nElectrons);
#endregion
#region Jordan–Wigner representation
// The Jordan–Wigner encoding converts the fermion Hamiltonian,
// expressed in terms of Fermionic operators, to a qubit Hamiltonian,
// expressed in terms of Pauli matrices. This is an essential step
// for simulating our constructed Hamiltonians on a qubit quantum
// computer.
Console.WriteLine("----- Creating Jordan–Wigner encoding");
var jordanWignerEncoding =
fermionHamiltonian.ToPauliHamiltonian(Paulis.QubitEncoding.JordanWigner);
Console.WriteLine("----- End Creating Jordan–Wigner encoding n");
// Print the Jordan–Wigner encoded Hamiltonian to see verify what it contains.
Console.WriteLine("----- Print Hamiltonian");
Console.Write(jordanWignerEncoding);
Console.WriteLine("----- End Print Hamiltonian n");
#endregion
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)
quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)

Contenu connexe

Tendances

不老におけるOptunaを利用した分散ハイパーパラメータ最適化 - 今村秀明(名古屋大学 Optuna講習会)
不老におけるOptunaを利用した分散ハイパーパラメータ最適化 - 今村秀明(名古屋大学 Optuna講習会)不老におけるOptunaを利用した分散ハイパーパラメータ最適化 - 今村秀明(名古屋大学 Optuna講習会)
不老におけるOptunaを利用した分散ハイパーパラメータ最適化 - 今村秀明(名古屋大学 Optuna講習会)Preferred Networks
 
Kaggle Happywhaleコンペ優勝解法でのOptuna使用事例 - 2022/12/10 Optuna Meetup #2
Kaggle Happywhaleコンペ優勝解法でのOptuna使用事例 - 2022/12/10 Optuna Meetup #2Kaggle Happywhaleコンペ優勝解法でのOptuna使用事例 - 2022/12/10 Optuna Meetup #2
Kaggle Happywhaleコンペ優勝解法でのOptuna使用事例 - 2022/12/10 Optuna Meetup #2Preferred Networks
 
簡易版AutoML+OptunaによるHyperparams Tuning
簡易版AutoML+OptunaによるHyperparams Tuning簡易版AutoML+OptunaによるHyperparams Tuning
簡易版AutoML+OptunaによるHyperparams TuningMasaharu Kinoshita
 
グラフニューラルネットワーク入門
グラフニューラルネットワーク入門グラフニューラルネットワーク入門
グラフニューラルネットワーク入門ryosuke-kojima
 
【DL輪読会】The Forward-Forward Algorithm: Some Preliminary
【DL輪読会】The Forward-Forward Algorithm: Some Preliminary【DL輪読会】The Forward-Forward Algorithm: Some Preliminary
【DL輪読会】The Forward-Forward Algorithm: Some PreliminaryDeep Learning JP
 
動的輪郭モデル
動的輪郭モデル動的輪郭モデル
動的輪郭モデルArumaziro
 
PFP:材料探索のための汎用Neural Network Potential_中郷_20220422POLセミナー
PFP:材料探索のための汎用Neural Network Potential_中郷_20220422POLセミナーPFP:材料探索のための汎用Neural Network Potential_中郷_20220422POLセミナー
PFP:材料探索のための汎用Neural Network Potential_中郷_20220422POLセミナーMatlantis
 
SSII2019TS: 実践カメラキャリブレーション ~カメラを用いた実世界計測の基礎と応用~
SSII2019TS: 実践カメラキャリブレーション ~カメラを用いた実世界計測の基礎と応用~SSII2019TS: 実践カメラキャリブレーション ~カメラを用いた実世界計測の基礎と応用~
SSII2019TS: 実践カメラキャリブレーション ~カメラを用いた実世界計測の基礎と応用~SSII
 
入門 Kubeflow ~Kubernetesで機械学習をはじめるために~ (NTT Tech Conference #4 講演資料)
入門 Kubeflow ~Kubernetesで機械学習をはじめるために~ (NTT Tech Conference #4 講演資料)入門 Kubeflow ~Kubernetesで機械学習をはじめるために~ (NTT Tech Conference #4 講演資料)
入門 Kubeflow ~Kubernetesで機械学習をはじめるために~ (NTT Tech Conference #4 講演資料)NTT DATA Technology & Innovation
 
Graph convolution (スペクトルアプローチ)
Graph convolution (スペクトルアプローチ)Graph convolution (スペクトルアプローチ)
Graph convolution (スペクトルアプローチ)yukihiro domae
 
マルチコアを用いた画像処理
マルチコアを用いた画像処理マルチコアを用いた画像処理
マルチコアを用いた画像処理Norishige Fukushima
 
よくわかるフリストンの自由エネルギー原理
よくわかるフリストンの自由エネルギー原理よくわかるフリストンの自由エネルギー原理
よくわかるフリストンの自由エネルギー原理Masatoshi Yoshida
 
Jetson活用セミナー ROS2自律走行実現に向けて
Jetson活用セミナー ROS2自律走行実現に向けてJetson活用セミナー ROS2自律走行実現に向けて
Jetson活用セミナー ROS2自律走行実現に向けてFixstars Corporation
 
ニューラルチューリングマシン入門
ニューラルチューリングマシン入門ニューラルチューリングマシン入門
ニューラルチューリングマシン入門naoto moriyama
 
SAT/SMTソルバの仕組み
SAT/SMTソルバの仕組みSAT/SMTソルバの仕組み
SAT/SMTソルバの仕組みMasahiro Sakai
 
レプリカ交換モンテカルロ法で乱数の生成
レプリカ交換モンテカルロ法で乱数の生成レプリカ交換モンテカルロ法で乱数の生成
レプリカ交換モンテカルロ法で乱数の生成Nagi Teramo
 
[DL輪読会]Whole-Body Human Pose Estimation in the Wild
[DL輪読会]Whole-Body Human Pose Estimation in the Wild[DL輪読会]Whole-Body Human Pose Estimation in the Wild
[DL輪読会]Whole-Body Human Pose Estimation in the WildDeep Learning JP
 
Sift特徴量について
Sift特徴量についてSift特徴量について
Sift特徴量についてla_flance
 
Newman アルゴリズムによるソーシャルグラフのクラスタリング
Newman アルゴリズムによるソーシャルグラフのクラスタリングNewman アルゴリズムによるソーシャルグラフのクラスタリング
Newman アルゴリズムによるソーシャルグラフのクラスタリングAtsushi KOMIYA
 
PFNのオンプレ計算機クラスタの取り組み_第55回情報科学若手の会
PFNのオンプレ計算機クラスタの取り組み_第55回情報科学若手の会PFNのオンプレ計算機クラスタの取り組み_第55回情報科学若手の会
PFNのオンプレ計算機クラスタの取り組み_第55回情報科学若手の会Preferred Networks
 

Tendances (20)

不老におけるOptunaを利用した分散ハイパーパラメータ最適化 - 今村秀明(名古屋大学 Optuna講習会)
不老におけるOptunaを利用した分散ハイパーパラメータ最適化 - 今村秀明(名古屋大学 Optuna講習会)不老におけるOptunaを利用した分散ハイパーパラメータ最適化 - 今村秀明(名古屋大学 Optuna講習会)
不老におけるOptunaを利用した分散ハイパーパラメータ最適化 - 今村秀明(名古屋大学 Optuna講習会)
 
Kaggle Happywhaleコンペ優勝解法でのOptuna使用事例 - 2022/12/10 Optuna Meetup #2
Kaggle Happywhaleコンペ優勝解法でのOptuna使用事例 - 2022/12/10 Optuna Meetup #2Kaggle Happywhaleコンペ優勝解法でのOptuna使用事例 - 2022/12/10 Optuna Meetup #2
Kaggle Happywhaleコンペ優勝解法でのOptuna使用事例 - 2022/12/10 Optuna Meetup #2
 
簡易版AutoML+OptunaによるHyperparams Tuning
簡易版AutoML+OptunaによるHyperparams Tuning簡易版AutoML+OptunaによるHyperparams Tuning
簡易版AutoML+OptunaによるHyperparams Tuning
 
グラフニューラルネットワーク入門
グラフニューラルネットワーク入門グラフニューラルネットワーク入門
グラフニューラルネットワーク入門
 
【DL輪読会】The Forward-Forward Algorithm: Some Preliminary
【DL輪読会】The Forward-Forward Algorithm: Some Preliminary【DL輪読会】The Forward-Forward Algorithm: Some Preliminary
【DL輪読会】The Forward-Forward Algorithm: Some Preliminary
 
動的輪郭モデル
動的輪郭モデル動的輪郭モデル
動的輪郭モデル
 
PFP:材料探索のための汎用Neural Network Potential_中郷_20220422POLセミナー
PFP:材料探索のための汎用Neural Network Potential_中郷_20220422POLセミナーPFP:材料探索のための汎用Neural Network Potential_中郷_20220422POLセミナー
PFP:材料探索のための汎用Neural Network Potential_中郷_20220422POLセミナー
 
SSII2019TS: 実践カメラキャリブレーション ~カメラを用いた実世界計測の基礎と応用~
SSII2019TS: 実践カメラキャリブレーション ~カメラを用いた実世界計測の基礎と応用~SSII2019TS: 実践カメラキャリブレーション ~カメラを用いた実世界計測の基礎と応用~
SSII2019TS: 実践カメラキャリブレーション ~カメラを用いた実世界計測の基礎と応用~
 
入門 Kubeflow ~Kubernetesで機械学習をはじめるために~ (NTT Tech Conference #4 講演資料)
入門 Kubeflow ~Kubernetesで機械学習をはじめるために~ (NTT Tech Conference #4 講演資料)入門 Kubeflow ~Kubernetesで機械学習をはじめるために~ (NTT Tech Conference #4 講演資料)
入門 Kubeflow ~Kubernetesで機械学習をはじめるために~ (NTT Tech Conference #4 講演資料)
 
Graph convolution (スペクトルアプローチ)
Graph convolution (スペクトルアプローチ)Graph convolution (スペクトルアプローチ)
Graph convolution (スペクトルアプローチ)
 
マルチコアを用いた画像処理
マルチコアを用いた画像処理マルチコアを用いた画像処理
マルチコアを用いた画像処理
 
よくわかるフリストンの自由エネルギー原理
よくわかるフリストンの自由エネルギー原理よくわかるフリストンの自由エネルギー原理
よくわかるフリストンの自由エネルギー原理
 
Jetson活用セミナー ROS2自律走行実現に向けて
Jetson活用セミナー ROS2自律走行実現に向けてJetson活用セミナー ROS2自律走行実現に向けて
Jetson活用セミナー ROS2自律走行実現に向けて
 
ニューラルチューリングマシン入門
ニューラルチューリングマシン入門ニューラルチューリングマシン入門
ニューラルチューリングマシン入門
 
SAT/SMTソルバの仕組み
SAT/SMTソルバの仕組みSAT/SMTソルバの仕組み
SAT/SMTソルバの仕組み
 
レプリカ交換モンテカルロ法で乱数の生成
レプリカ交換モンテカルロ法で乱数の生成レプリカ交換モンテカルロ法で乱数の生成
レプリカ交換モンテカルロ法で乱数の生成
 
[DL輪読会]Whole-Body Human Pose Estimation in the Wild
[DL輪読会]Whole-Body Human Pose Estimation in the Wild[DL輪読会]Whole-Body Human Pose Estimation in the Wild
[DL輪読会]Whole-Body Human Pose Estimation in the Wild
 
Sift特徴量について
Sift特徴量についてSift特徴量について
Sift特徴量について
 
Newman アルゴリズムによるソーシャルグラフのクラスタリング
Newman アルゴリズムによるソーシャルグラフのクラスタリングNewman アルゴリズムによるソーシャルグラフのクラスタリング
Newman アルゴリズムによるソーシャルグラフのクラスタリング
 
PFNのオンプレ計算機クラスタの取り組み_第55回情報科学若手の会
PFNのオンプレ計算機クラスタの取り組み_第55回情報科学若手の会PFNのオンプレ計算機クラスタの取り組み_第55回情報科学若手の会
PFNのオンプレ計算機クラスタの取り組み_第55回情報科学若手の会
 

Similaire à quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)

Numerical Algorithm for a few Special Functions
Numerical Algorithm for a few Special FunctionsNumerical Algorithm for a few Special Functions
Numerical Algorithm for a few Special FunctionsAmos Tsai
 
Vector time series sas-writing sample
Vector time series sas-writing sampleVector time series sas-writing sample
Vector time series sas-writing sampleQingyang Liu
 
How To Crack RSA Netrek Binary Verification System
How To Crack RSA Netrek Binary Verification SystemHow To Crack RSA Netrek Binary Verification System
How To Crack RSA Netrek Binary Verification SystemJay Corrales
 
Compilation of COSMO for GPU using LLVM
Compilation of COSMO for GPU using LLVMCompilation of COSMO for GPU using LLVM
Compilation of COSMO for GPU using LLVMLinaro
 
Introduction to NumPy for Machine Learning Programmers
Introduction to NumPy for Machine Learning ProgrammersIntroduction to NumPy for Machine Learning Programmers
Introduction to NumPy for Machine Learning ProgrammersKimikazu Kato
 
Arna Friend Controls II Final
Arna Friend Controls II FinalArna Friend Controls II Final
Arna Friend Controls II FinalArna Friend
 
Fast Algorithm for Computing the Discrete Hartley Transform of Type-II
Fast Algorithm for Computing the Discrete Hartley Transform of Type-IIFast Algorithm for Computing the Discrete Hartley Transform of Type-II
Fast Algorithm for Computing the Discrete Hartley Transform of Type-IIijeei-iaes
 
How to add an optimization for C# to RyuJIT
How to add an optimization for C# to RyuJITHow to add an optimization for C# to RyuJIT
How to add an optimization for C# to RyuJITEgor Bogatov
 
A Course in Fuzzy Systems and Control Matlab Chapter two
A Course in Fuzzy Systems and Control Matlab Chapter twoA Course in Fuzzy Systems and Control Matlab Chapter two
A Course in Fuzzy Systems and Control Matlab Chapter twoChung Hua Universit
 
Direct split-radix algorithm for fast computation of type-II discrete Hartley...
Direct split-radix algorithm for fast computation of type-II discrete Hartley...Direct split-radix algorithm for fast computation of type-II discrete Hartley...
Direct split-radix algorithm for fast computation of type-II discrete Hartley...TELKOMNIKA JOURNAL
 
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...Shizuoka Inst. Science and Tech.
 
Declare Your Language: Transformation by Strategic Term Rewriting
Declare Your Language: Transformation by Strategic Term RewritingDeclare Your Language: Transformation by Strategic Term Rewriting
Declare Your Language: Transformation by Strategic Term RewritingEelco Visser
 
Towards Auto-tuning Facilities into Supercomputers in Operation - The FIBER a...
Towards Auto-tuning Facilities into Supercomputers in Operation - The FIBER a...Towards Auto-tuning Facilities into Supercomputers in Operation - The FIBER a...
Towards Auto-tuning Facilities into Supercomputers in Operation - The FIBER a...Takahiro Katagiri
 
Comparison GUM versus GUM+1
Comparison GUM  versus GUM+1Comparison GUM  versus GUM+1
Comparison GUM versus GUM+1Maurice Maeck
 
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdfreservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdfRTEFGDFGJU
 
DFT-hands-on-nguyen_notas_Presentación.pdf
DFT-hands-on-nguyen_notas_Presentación.pdfDFT-hands-on-nguyen_notas_Presentación.pdf
DFT-hands-on-nguyen_notas_Presentación.pdfMiguelHernandezVazqu2
 
vibration of machines and structures
vibration of machines and structuresvibration of machines and structures
vibration of machines and structuresAniruddhsinh Barad
 

Similaire à quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo) (20)

Numerical Algorithm for a few Special Functions
Numerical Algorithm for a few Special FunctionsNumerical Algorithm for a few Special Functions
Numerical Algorithm for a few Special Functions
 
Vector time series sas-writing sample
Vector time series sas-writing sampleVector time series sas-writing sample
Vector time series sas-writing sample
 
How To Crack RSA Netrek Binary Verification System
How To Crack RSA Netrek Binary Verification SystemHow To Crack RSA Netrek Binary Verification System
How To Crack RSA Netrek Binary Verification System
 
Compilation of COSMO for GPU using LLVM
Compilation of COSMO for GPU using LLVMCompilation of COSMO for GPU using LLVM
Compilation of COSMO for GPU using LLVM
 
Introduction to NumPy for Machine Learning Programmers
Introduction to NumPy for Machine Learning ProgrammersIntroduction to NumPy for Machine Learning Programmers
Introduction to NumPy for Machine Learning Programmers
 
Arna Friend Controls II Final
Arna Friend Controls II FinalArna Friend Controls II Final
Arna Friend Controls II Final
 
Fast Algorithm for Computing the Discrete Hartley Transform of Type-II
Fast Algorithm for Computing the Discrete Hartley Transform of Type-IIFast Algorithm for Computing the Discrete Hartley Transform of Type-II
Fast Algorithm for Computing the Discrete Hartley Transform of Type-II
 
How to add an optimization for C# to RyuJIT
How to add an optimization for C# to RyuJITHow to add an optimization for C# to RyuJIT
How to add an optimization for C# to RyuJIT
 
A Course in Fuzzy Systems and Control Matlab Chapter two
A Course in Fuzzy Systems and Control Matlab Chapter twoA Course in Fuzzy Systems and Control Matlab Chapter two
A Course in Fuzzy Systems and Control Matlab Chapter two
 
Direct split-radix algorithm for fast computation of type-II discrete Hartley...
Direct split-radix algorithm for fast computation of type-II discrete Hartley...Direct split-radix algorithm for fast computation of type-II discrete Hartley...
Direct split-radix algorithm for fast computation of type-II discrete Hartley...
 
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
 
13486500-FFT.ppt
13486500-FFT.ppt13486500-FFT.ppt
13486500-FFT.ppt
 
Declare Your Language: Transformation by Strategic Term Rewriting
Declare Your Language: Transformation by Strategic Term RewritingDeclare Your Language: Transformation by Strategic Term Rewriting
Declare Your Language: Transformation by Strategic Term Rewriting
 
Seminar PSU 10.10.2014 mme
Seminar PSU 10.10.2014 mmeSeminar PSU 10.10.2014 mme
Seminar PSU 10.10.2014 mme
 
Towards Auto-tuning Facilities into Supercomputers in Operation - The FIBER a...
Towards Auto-tuning Facilities into Supercomputers in Operation - The FIBER a...Towards Auto-tuning Facilities into Supercomputers in Operation - The FIBER a...
Towards Auto-tuning Facilities into Supercomputers in Operation - The FIBER a...
 
Comparison GUM versus GUM+1
Comparison GUM  versus GUM+1Comparison GUM  versus GUM+1
Comparison GUM versus GUM+1
 
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdfreservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
 
PRACTICAL COMPUTING
PRACTICAL COMPUTINGPRACTICAL COMPUTING
PRACTICAL COMPUTING
 
DFT-hands-on-nguyen_notas_Presentación.pdf
DFT-hands-on-nguyen_notas_Presentación.pdfDFT-hands-on-nguyen_notas_Presentación.pdf
DFT-hands-on-nguyen_notas_Presentación.pdf
 
vibration of machines and structures
vibration of machines and structuresvibration of machines and structures
vibration of machines and structures
 

Plus de Maho Nakata

Lie-Trotter-Suzuki分解、特にフラクタル分解について
Lie-Trotter-Suzuki分解、特にフラクタル分解についてLie-Trotter-Suzuki分解、特にフラクタル分解について
Lie-Trotter-Suzuki分解、特にフラクタル分解についてMaho Nakata
 
LiHのポテンシャルエネルギー曲面 を量子コンピュータで行う Q#+位相推定編
LiHのポテンシャルエネルギー曲面 を量子コンピュータで行う Q#+位相推定編LiHのポテンシャルエネルギー曲面 を量子コンピュータで行う Q#+位相推定編
LiHのポテンシャルエネルギー曲面 を量子コンピュータで行う Q#+位相推定編Maho Nakata
 
Q#による量子化学計算 : 水素分子の位相推定について
Q#による量子化学計算 : 水素分子の位相推定についてQ#による量子化学計算 : 水素分子の位相推定について
Q#による量子化学計算 : 水素分子の位相推定についてMaho Nakata
 
20180723 量子コンピュータの量子化学への応用; Bravyi-Kitaev基底の実装
20180723 量子コンピュータの量子化学への応用; Bravyi-Kitaev基底の実装20180723 量子コンピュータの量子化学への応用; Bravyi-Kitaev基底の実装
20180723 量子コンピュータの量子化学への応用; Bravyi-Kitaev基底の実装Maho Nakata
 
第11回分子科学 2017/9/17 Pubchemqcプロジェクト
第11回分子科学 2017/9/17 Pubchemqcプロジェクト第11回分子科学 2017/9/17 Pubchemqcプロジェクト
第11回分子科学 2017/9/17 PubchemqcプロジェクトMaho Nakata
 
Kobeworkshop pubchemqc project
Kobeworkshop pubchemqc projectKobeworkshop pubchemqc project
Kobeworkshop pubchemqc projectMaho Nakata
 
計算化学実習講座:第二回
 計算化学実習講座:第二回 計算化学実習講座:第二回
計算化学実習講座:第二回Maho Nakata
 
計算化学実習講座:第一回
計算化学実習講座:第一回計算化学実習講座:第一回
計算化学実習講座:第一回Maho Nakata
 
HOKUSAIのベンチマーク 理研シンポジウム 中田分
HOKUSAIのベンチマーク 理研シンポジウム 中田分HOKUSAIのベンチマーク 理研シンポジウム 中田分
HOKUSAIのベンチマーク 理研シンポジウム 中田分Maho Nakata
 
為替取引(FX)でのtickdataの加工とMySQLで管理
為替取引(FX)でのtickdataの加工とMySQLで管理為替取引(FX)でのtickdataの加工とMySQLで管理
為替取引(FX)でのtickdataの加工とMySQLで管理Maho Nakata
 
為替のTickdataをDukascopyからダウンロードする
為替のTickdataをDukascopyからダウンロードする為替のTickdataをDukascopyからダウンロードする
為替のTickdataをDukascopyからダウンロードするMaho Nakata
 
HPCS2015 pythonを用いた量子化学プログラムの開発と応用
HPCS2015 pythonを用いた量子化学プログラムの開発と応用HPCS2015 pythonを用いた量子化学プログラムの開発と応用
HPCS2015 pythonを用いた量子化学プログラムの開発と応用Maho Nakata
 
HPCS2015 大規模量子化学計算プログラムSMASHの開発と公開(石村)
HPCS2015 大規模量子化学計算プログラムSMASHの開発と公開(石村)HPCS2015 大規模量子化学計算プログラムSMASHの開発と公開(石村)
HPCS2015 大規模量子化学計算プログラムSMASHの開発と公開(石村)Maho Nakata
 
The PubChemQC Project
The PubChemQC ProjectThe PubChemQC Project
The PubChemQC ProjectMaho Nakata
 
3Dプリンタ導入記 タンパク質の模型をプリントする
3Dプリンタ導入記 タンパク質の模型をプリントする3Dプリンタ導入記 タンパク質の模型をプリントする
3Dプリンタ導入記 タンパク質の模型をプリントするMaho Nakata
 
QuantumChemistry500
QuantumChemistry500QuantumChemistry500
QuantumChemistry500Maho Nakata
 
立教大学化学実験3 SMILESを中心とした高度な分子モデリング 2014/7/1
立教大学化学実験3 SMILESを中心とした高度な分子モデリング 2014/7/1 立教大学化学実験3 SMILESを中心とした高度な分子モデリング 2014/7/1
立教大学化学実験3 SMILESを中心とした高度な分子モデリング 2014/7/1 Maho Nakata
 
The PubchemQC project
The PubchemQC projectThe PubchemQC project
The PubchemQC projectMaho Nakata
 
Direct variational calculation of second-order reduced density matrix : appli...
Direct variational calculation of second-order reduced density matrix : appli...Direct variational calculation of second-order reduced density matrix : appli...
Direct variational calculation of second-order reduced density matrix : appli...Maho Nakata
 
高精度線形代数演算ライブラリMPACK 0.8.0の紹介
高精度線形代数演算ライブラリMPACK 0.8.0の紹介高精度線形代数演算ライブラリMPACK 0.8.0の紹介
高精度線形代数演算ライブラリMPACK 0.8.0の紹介Maho Nakata
 

Plus de Maho Nakata (20)

Lie-Trotter-Suzuki分解、特にフラクタル分解について
Lie-Trotter-Suzuki分解、特にフラクタル分解についてLie-Trotter-Suzuki分解、特にフラクタル分解について
Lie-Trotter-Suzuki分解、特にフラクタル分解について
 
LiHのポテンシャルエネルギー曲面 を量子コンピュータで行う Q#+位相推定編
LiHのポテンシャルエネルギー曲面 を量子コンピュータで行う Q#+位相推定編LiHのポテンシャルエネルギー曲面 を量子コンピュータで行う Q#+位相推定編
LiHのポテンシャルエネルギー曲面 を量子コンピュータで行う Q#+位相推定編
 
Q#による量子化学計算 : 水素分子の位相推定について
Q#による量子化学計算 : 水素分子の位相推定についてQ#による量子化学計算 : 水素分子の位相推定について
Q#による量子化学計算 : 水素分子の位相推定について
 
20180723 量子コンピュータの量子化学への応用; Bravyi-Kitaev基底の実装
20180723 量子コンピュータの量子化学への応用; Bravyi-Kitaev基底の実装20180723 量子コンピュータの量子化学への応用; Bravyi-Kitaev基底の実装
20180723 量子コンピュータの量子化学への応用; Bravyi-Kitaev基底の実装
 
第11回分子科学 2017/9/17 Pubchemqcプロジェクト
第11回分子科学 2017/9/17 Pubchemqcプロジェクト第11回分子科学 2017/9/17 Pubchemqcプロジェクト
第11回分子科学 2017/9/17 Pubchemqcプロジェクト
 
Kobeworkshop pubchemqc project
Kobeworkshop pubchemqc projectKobeworkshop pubchemqc project
Kobeworkshop pubchemqc project
 
計算化学実習講座:第二回
 計算化学実習講座:第二回 計算化学実習講座:第二回
計算化学実習講座:第二回
 
計算化学実習講座:第一回
計算化学実習講座:第一回計算化学実習講座:第一回
計算化学実習講座:第一回
 
HOKUSAIのベンチマーク 理研シンポジウム 中田分
HOKUSAIのベンチマーク 理研シンポジウム 中田分HOKUSAIのベンチマーク 理研シンポジウム 中田分
HOKUSAIのベンチマーク 理研シンポジウム 中田分
 
為替取引(FX)でのtickdataの加工とMySQLで管理
為替取引(FX)でのtickdataの加工とMySQLで管理為替取引(FX)でのtickdataの加工とMySQLで管理
為替取引(FX)でのtickdataの加工とMySQLで管理
 
為替のTickdataをDukascopyからダウンロードする
為替のTickdataをDukascopyからダウンロードする為替のTickdataをDukascopyからダウンロードする
為替のTickdataをDukascopyからダウンロードする
 
HPCS2015 pythonを用いた量子化学プログラムの開発と応用
HPCS2015 pythonを用いた量子化学プログラムの開発と応用HPCS2015 pythonを用いた量子化学プログラムの開発と応用
HPCS2015 pythonを用いた量子化学プログラムの開発と応用
 
HPCS2015 大規模量子化学計算プログラムSMASHの開発と公開(石村)
HPCS2015 大規模量子化学計算プログラムSMASHの開発と公開(石村)HPCS2015 大規模量子化学計算プログラムSMASHの開発と公開(石村)
HPCS2015 大規模量子化学計算プログラムSMASHの開発と公開(石村)
 
The PubChemQC Project
The PubChemQC ProjectThe PubChemQC Project
The PubChemQC Project
 
3Dプリンタ導入記 タンパク質の模型をプリントする
3Dプリンタ導入記 タンパク質の模型をプリントする3Dプリンタ導入記 タンパク質の模型をプリントする
3Dプリンタ導入記 タンパク質の模型をプリントする
 
QuantumChemistry500
QuantumChemistry500QuantumChemistry500
QuantumChemistry500
 
立教大学化学実験3 SMILESを中心とした高度な分子モデリング 2014/7/1
立教大学化学実験3 SMILESを中心とした高度な分子モデリング 2014/7/1 立教大学化学実験3 SMILESを中心とした高度な分子モデリング 2014/7/1
立教大学化学実験3 SMILESを中心とした高度な分子モデリング 2014/7/1
 
The PubchemQC project
The PubchemQC projectThe PubchemQC project
The PubchemQC project
 
Direct variational calculation of second-order reduced density matrix : appli...
Direct variational calculation of second-order reduced density matrix : appli...Direct variational calculation of second-order reduced density matrix : appli...
Direct variational calculation of second-order reduced density matrix : appli...
 
高精度線形代数演算ライブラリMPACK 0.8.0の紹介
高精度線形代数演算ライブラリMPACK 0.8.0の紹介高精度線形代数演算ライブラリMPACK 0.8.0の紹介
高精度線形代数演算ライブラリMPACK 0.8.0の紹介
 

Dernier

Isotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on IoIsotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on IoSérgio Sacani
 
Artificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C PArtificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C PPRINCE C P
 
Boyles law module in the grade 10 science
Boyles law module in the grade 10 scienceBoyles law module in the grade 10 science
Boyles law module in the grade 10 sciencefloriejanemacaya1
 
Botany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdfBotany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdfSumit Kumar yadav
 
Is RISC-V ready for HPC workload? Maybe?
Is RISC-V ready for HPC workload? Maybe?Is RISC-V ready for HPC workload? Maybe?
Is RISC-V ready for HPC workload? Maybe?Patrick Diehl
 
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxkessiyaTpeter
 
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
 
Biological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdfBiological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdfmuntazimhurra
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxpradhanghanshyam7136
 
Formation of low mass protostars and their circumstellar disks
Formation of low mass protostars and their circumstellar disksFormation of low mass protostars and their circumstellar disks
Formation of low mass protostars and their circumstellar disksSérgio Sacani
 
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...Lokesh Kothari
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSarthak Sekhar Mondal
 
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
 
Physiochemical properties of nanomaterials and its nanotoxicity.pptx
Physiochemical properties of nanomaterials and its nanotoxicity.pptxPhysiochemical properties of nanomaterials and its nanotoxicity.pptx
Physiochemical properties of nanomaterials and its nanotoxicity.pptxAArockiyaNisha
 
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
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsAArockiyaNisha
 
Work, Energy and Power for class 10 ICSE Physics
Work, Energy and Power for class 10 ICSE PhysicsWork, Energy and Power for class 10 ICSE Physics
Work, Energy and Power for class 10 ICSE Physicsvishikhakeshava1
 
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
 
Grafana in space: Monitoring Japan's SLIM moon lander in real time
Grafana in space: Monitoring Japan's SLIM moon lander  in real timeGrafana in space: Monitoring Japan's SLIM moon lander  in real time
Grafana in space: Monitoring Japan's SLIM moon lander in real timeSatoshi NAKAHIRA
 

Dernier (20)

Isotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on IoIsotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on Io
 
Artificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C PArtificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C P
 
Boyles law module in the grade 10 science
Boyles law module in the grade 10 scienceBoyles law module in the grade 10 science
Boyles law module in the grade 10 science
 
Botany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdfBotany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdf
 
Is RISC-V ready for HPC workload? Maybe?
Is RISC-V ready for HPC workload? Maybe?Is RISC-V ready for HPC workload? Maybe?
Is RISC-V ready for HPC workload? Maybe?
 
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
 
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...
 
Biological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdfBiological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdf
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptx
 
9953056974 Young Call Girls In Mahavir enclave Indian Quality Escort service
9953056974 Young Call Girls In Mahavir enclave Indian Quality Escort service9953056974 Young Call Girls In Mahavir enclave Indian Quality Escort service
9953056974 Young Call Girls In Mahavir enclave Indian Quality Escort service
 
Formation of low mass protostars and their circumstellar disks
Formation of low mass protostars and their circumstellar disksFormation of low mass protostars and their circumstellar disks
Formation of low mass protostars and their circumstellar disks
 
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
 
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
 
Physiochemical properties of nanomaterials and its nanotoxicity.pptx
Physiochemical properties of nanomaterials and its nanotoxicity.pptxPhysiochemical properties of nanomaterials and its nanotoxicity.pptx
Physiochemical properties of nanomaterials and its nanotoxicity.pptx
 
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
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based Nanomaterials
 
Work, Energy and Power for class 10 ICSE Physics
Work, Energy and Power for class 10 ICSE PhysicsWork, Energy and Power for class 10 ICSE Physics
Work, Energy and Power for class 10 ICSE Physics
 
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...
 
Grafana in space: Monitoring Japan's SLIM moon lander in real time
Grafana in space: Monitoring Japan's SLIM moon lander  in real timeGrafana in space: Monitoring Japan's SLIM moon lander  in real time
Grafana in space: Monitoring Japan's SLIM moon lander in real time
 

quantum chemistry on quantum computer handson by Q# (2019/8/4@MDR Hongo, Tokyo)

  • 1.
  • 2.
  • 3.
  • 5. ̂HΨ(r1, ⋯, rN) = EΨ(r1, ⋯, rN) ̂H Ψ E ̂H = − ℏ2 2me ∇2 1 − ℏ2 2me ∇2 2 − e2 4πϵ0 ( 1 ra1 + 1 rb1 + 1 ra2 + 1 rb2 ) + e2 4πϵ0 1 r12 + e2 4πϵ0R Ψ(x1, y1, z1, x2, y2, z2)
  • 7.
  • 8.
  • 9.
  • 10.
  • 11.
  • 12.
  • 13. N 1 N − 1 N − 1 3N 3 N |⟨ΨfullCI |ΨHartree−Fock⟩|2 ≈ 1 1 3N N
  • 14. |Ψ0⟩ {χa}i=1,⋯,r Ψ0⟩ = χ1χ2⋯χa χb⋯χN⟩ E0 = ⟨Ψ0 | ̂ℋ|Ψ0⟩ = ∑ a ⟨a|h|a⟩ + 1 2 ∑ ab ⟨ab||ab⟩ ⟨χa |χb⟩ = δab
  • 15. [ h(1) + N ∑ b=1 𝒥b(1) − 𝒦b(1) ] χa(1) = N ∑ b=1 εba χb(1) f χa⟩ = N ∑ b=1 εba xb⟩ f χa⟩ = εa χa⟩
  • 16. {ϕμ} ψi = K ∑ μ=1 Cμiϕμ Sμv = ∫ dr1ϕ*μ (1)ϕv(1) Fμv = ∫ dr1ϕ*μ (1)f(1)ϕv(1) ∑ v FμvCvi = εi ∑ v SμvCvi FC = SCε
  • 17. FC = SCε Fμv = Hcore μv + ∑ a ∑ λσ CλaC*σa[2(μv|σλ) − (μλ|σv)]
  • 18.
  • 19.
  • 20.
  • 21.
  • 22. $ sudo apt install psi4 python3-numpy libopenblas-dev …
  • 23.
  • 24. #! STO-3G H2 Hartree-Fock Energy Point # see also: http://pubchemqc.riken.jp/cgi-bin/molecularquery.py?name=hydrogen molecule h2 { H 0.0 0.0 0.0 H 0.0 0.0 1.4 unit bohr } set { basis STO-3G } thisenergy = energy('hf')
  • 25.
  • 26.
  • 27. #! STO-3G H2 Hartree-Fock Energy Point # see also: http://pubchemqc.riken.jp/cgi-bin/molecularquery.py?name=hydrogen molecule h2 { H 0.0 0.0 0.0 H 0.0 0.0 1.4 unit bohr } set { basis STO-3G } thisenergy = energy('hf')
  • 28. **** H 0 S 3 1.00 3.42525091 0.15432897 0.62391373 0.53532814 0.16885540 0.44463454
  • 29.
  • 30.
  • 31. en, wfn = energy('hf', return_wfn=True) nbf = wfn.nso() mints = psi4.core.MintsHelper(wfn.basisset()) S = np.asarray(mints.ao_overlap()) for i in range(nbf): for j in range(nbf): print (i+1,j+1, S[i,j])
  • 33.
  • 34.
  • 35.
  • 36.
  • 37.
  • 38. |Ψ0⟩ {χa}i=1,⋯,r |Ψ0⟩ = |χ1χ2⋯χa χb⋯χN⟩ {χa}i=1,⋯,r
  • 39. |Ψ0⟩ |Ψ⟩ = c0 |Φ0⟩ + occ ∑ i vir ∑ a ca i |Φa i ⟩ + occ ∑ i<j vir ∑ a<b cab ij |Φab ij ⟩ + occ ∑ i<j<k vir ∑ a<b<c cabc ijk |Φabc ijk ⟩ + ⋯ |Φ0⟩ |Φ0⟩ = |χ1χ2⋯χa χb⋯χN⟩ |Φa i ⟩ |Φa i ⟩ = |χ1χ2⋯χi−1χa χi+1⋯χN⟩ |Φab ij ⟩ |Φab ij ⟩ = |χ1χ2⋯χi−1χa χi+1⋯χj−1χb χj+1⋯χN⟩ ca i , cab ij
  • 40. |Ψ⟩ = c0 |Φ0⟩ + occ ∑ i vir ∑ a ca i |Φa i ⟩ + occ ∑ i<j vir ∑ a<b cab ij |Φab ij ⟩ + occ ∑ i<j<k vir ∑ a<b<c cabc ijk |Φabc ijk ⟩ + ⋯ min ⟨Ψ|Ψ⟩=1 ⟨Ψ| ̂H|Ψ⟩
  • 41. rCN
  • 42.
  • 43. #! STO-3G H2 FullCI Energy Point # see also: http://pubchemqc.riken.jp/cgi-bin/molecularquery.py?name=hydrogen molecule h2 { H 0.0 0.0 0.0 H 0.0 0.0 1.4 unit bohr } set { basis STO-3G } thisenergy = energy(‘fci')
  • 45.
  • 46. |Ψ⟩ = c0 |Φ0⟩ + occ ∑ i vir ∑ a ca i |Φa i ⟩ + occ ∑ i<j vir ∑ a<b cab ij |Φab ij ⟩ + occ ∑ i<j<k vir ∑ a<b<c cabc ijk |Φabc ijk ⟩ + ⋯ |ΨfullCI⟩ = − 0.993627|ΦHF⟩ + 0.112716|Φ2¯2 1¯1 ⟩ |⟨ΨFullCI |ΦHF⟩|2 = 0.9872
  • 47.
  • 48.
  • 50.
  • 51.
  • 53. (7C5)2 = 21 * 21 = 441
  • 54.
  • 55.
  • 56.
  • 57.
  • 58.
  • 59. : CCSD(T), MP2 14_n2_631g_cc_mp_pes.dat N-N FullCI Hartree-Fock CCSD(T) MP2 fullCI (1.5A ?)
  • 60.
  • 62.
  • 63.
  • 64. |11⟩, |01⟩, |10⟩, |00⟩ |111⟩, |101⟩, |110⟩, |100⟩ |011⟩, |001⟩, |010⟩, |000⟩ |1⟩, |0⟩ |00000000⟩ + |00000001⟩ + . . . + |11111111⟩
  • 65.
  • 66.
  • 67.
  • 68. ei ̂Ht |ΦHF⟩ = c0eiE0t |Ψ0⟩ + c1eiE1t |Ψ1⟩ + c2eiE2t |Ψ2⟩⋯ ei ̂Hτ ≈ ∏ i eHΔτi ≈ ∏ i e ∑j HjΔτi ̂H|Ψ⟩ = E|Ψ⟩ → ei ̂Hτ |Ψ⟩ = ̂U|Ψ⟩ = ei2πϕ |Ψ⟩ ei2πϕ |Ψ⟩ ⊗ |R⟩ → ei2πϕ |Ψ⟩ ⊗ ei2πϕ |R⟩ → measure|R⟩ → E = 2πϕ/τ
  • 69. |⟨ΦFullCI |ΦHF⟩|2 ≈ 1 E0 ≤ E1 ≤ E2 ≤ ⋯
  • 70.
  • 71.
  • 72.
  • 73.
  • 74.
  • 75. $ dotnet new -i “Microsoft.Quantum.ProjectTemplates::0.7-*” …
  • 76. $ mkdir -p qsharp $ cd qsharp $ sudo apt install git $ git clone https://github.com/Microsoft/Quantum.git $ git clone https://github.com/microsoft/QuantumLibraries
  • 77.
  • 78.
  • 79. |ψ⟩ CNOT(H ⊗ 1)|00⟩ ⟶ |00⟩ + |11⟩ 2
  • 80. |ψ⟩ = α|0⟩ + β|1⟩ |ψ⟩ ⊗ |00⟩ + |11⟩ 2 (H ⊗ 1 ⊗ 1)[CNOT ⊗ 1]|ψ⟩ ⊗ |00⟩ + |11⟩ 2 = 1 2 [α|000⟩ + α|100⟩ + α|011⟩ + α|111⟩ + β|010⟩ − β|110⟩ + β|001⟩ − β|101⟩] 1 2 [|00⟩(α|0⟩ + β|1⟩) + |01⟩(α|1⟩ + β|0⟩) + |10⟩(α|0⟩ − β|1⟩) + |11⟩(α|1⟩ − β|0⟩)]
  • 81.
  • 82. $ cd Quantum/Samples/src/Teleportation $ dotnet run Round 0: Sent True, got True. Teleportation successful!! Round 1: Sent False, got False. Teleportation successful!! Round 2: Sent False, got False. Teleportation successful!! Round 3: Sent True, got True. Teleportation successful!! Round 4: Sent False, got False. Teleportation successful!! Round 5: Sent True, got True. Teleportation successful!! Round 6: Sent True, got True. Teleportation successful!! Round 7: Sent False, got False. Teleportation successful!!
  • 83. operation Teleport (msg : Qubit, target : Qubit) : Unit { using (register = Qubit()) { // Create some entanglement that we can use to send our message. H(register); CNOT(register, target); // Encode the message into the entangled pair, // and measure the qubits to extract the classical data // we need to correctly decode the message into the target qubit: CNOT(msg, register); H(msg); let data1 = M(msg); let data2 = M(register); // decode the message by applying the corrections on // the target qubit accordingly: if (data1 == One) { Z(target); } if (data2 == One) { X(target); } // Reset our "register" qubit before releasing it. Reset(register); } }
  • 84. // Copyright (c) Microsoft Corporation. All rights reserved. // Licensed under the MIT License. using Microsoft.Quantum.Simulation.Simulators; using System.Linq; namespace Microsoft.Quantum.Samples.Teleportation { class Program { static void Main(string[] args) { using (var sim = new QuantumSimulator()) { var rand = new System.Random(); foreach (var idxRun in Enumerable.Range(0, 8)) { var sent = rand.Next(2) == 0; var received = TeleportClassicalMessage.Run(sim, sent).Result; System.Console.WriteLine($"Round {idxRun}:tSent {sent},tgot {received}."); System.Console.WriteLine(sent == received ? "Teleportation successful!!n" : "n"); } } } } }
  • 85.
  • 86.
  • 87. ̂H = ∑ i,j vija† i aj + 1 2 ∑ ijkl wijkla† i a† j alak |Ψ⟩ ̂H|Ψ⟩ = E|Ψ⟩
  • 88. |⟨ΦFullCI |ΦHF⟩|2 ≈ 1 E0 ≤ E1 ≤ E2 ≤ ⋯
  • 89. |Ψ⟩ = c0 |Φ0⟩ + occ ∑ i vir ∑ a ca i |Φa i ⟩ + occ ∑ i<j vir ∑ a<b cab ij |Φab ij ⟩ + occ ∑ i<j<k vir ∑ a<b<c cabc ijk |Φabc ijk ⟩ + ⋯ |Φ0⟩ = |χ1χ2⋯χa χb⋯χN⟩ |Φa i ⟩ = |χ1χ2⋯χi−1χa χi+1⋯χN⟩ |Φab ij ⟩ = |χ1χ2⋯χi−1χa χi+1⋯χj−1χb χj+1⋯χN⟩ = |111111000000⟩ = |111110001000⟩ = |110110001010⟩ 2r r ≃ log(2r )
  • 90. 1/ N! ̂P12Ψ(x1, x2) = ± Ψ(x1, x2)
  • 91. ̂H|Ψ⟩ = E|Ψ⟩ → ei ̂Hτ |Ψ⟩ = ̂U|Ψ⟩ = ei2πϕ |Ψ⟩ ei2πϕ |Ψ⟩ ⊗ |R⟩ → ei2πϕ |Ψ⟩ ⊗ ei2πϕ |R⟩ → measure|R⟩ → E = 2πϕ/τ
  • 92. ̂H = ∑ i,j vija† i aj + 1 2 ∑ ijkl wijkla† i a† j alak ̂H = ∑ ijkl Hijkla† i a† j alak ei ̂Ht |ΦHF⟩ = c0eiE0t |Ψ0⟩ + c1eiE1t |Ψ1⟩ + c2eiE2t |Ψ2⟩⋯ exp(i ̂Ht) Hijkla† i a† j alak ei ̂Ht ≈ ∏ Δt eHΔt ≈ ∏ Δt e ∑ijkl HijklΔt ≈ ∏ Δt,ijkl eHijklΔt
  • 94. |⟨ΦFullCI |ΦHF⟩|2 ≈ 1 E0 ≤ E1 ≤ E2 ≤ ⋯ ei ̂Ht |ΦHF⟩ = c0eiE0t |Ψ0⟩ + c1eiE1t |Ψ1⟩ + c2eiE2t |Ψ2⟩⋯
  • 95.
  • 96.
  • 97. $ cd Quantum/Chemistry/MolecularHydrogen $ dotnet run ----- Print Hamiltonian PP has 4 entries). [1 * 0u 0d, -1.252477495] [1 * 1u 1d, -1.252477495] [1 * 2u 2d, -0.475934275] [1 * 3u 3d, -0.475934275] PQQP has 6 entries). [1 * 0u 1u 1d 0d, 0.674493166] [1 * 0u 2u 2d 0d, 0.482184583] [1 * 1u 3u 3d 1d, 0.482184583] [1 * 1u 2u 2d 1d, 0.663472101] [1 * 0u 3u 3d 0d, 0.663472101] [1 * 2u 3u 3d 2d, 0.69739801] PQRS has 2 entries). [1 * 0u 3u 2d 1d, -0.362575036] [1 * 0u 1u 3d 2d, 0.362575036] Identity has 1 entries). [1 * , 0.713776188] ----- End Print Hamiltonian ----- Creating Jordan–Wigner encoding ----- End Creating Jordan–Wigner encoding ----- Print Hamiltonian Identity has 1 entries). [Identity: [ ], -0.098834446] Z has 4 entries). [Z: [ 0 ], 0.171201285] [Z: [ 1 ], 0.171201285] [Z: [ 2 ], -0.222796536] [Z: [ 3 ], -0.222796536] ZZ has 6 entries). [ZZ: [ 0 1 ], 0.1686232915] [ZZ: [ 0 2 ], 0.12054614575] [ZZ: [ 1 3 ], 0.12054614575] [ZZ: [ 1 2 ], 0.16586802525] [ZZ: [ 0 3 ], 0.16586802525] [ZZ: [ 2 3 ], 0.1743495025] v01234 has 1 entries). [v01234: [ 0 1 2 3 ], 0, -0.0453218795, 0, 0.0453218795] ----- End Print Hamiltonian $ psi4 07_h2_sto3g_hf_dumpint.dat 1 electron integral 1 1 -1.25247730398 2 2 -0.475934461144 2 electron integral 1 1 1 1 0.674493103326 1 2 1 2 0.181287535812 2 2 1 1 0.663472044861 2 2 2 2 0.69739794982
  • 98. Exact molecular Hydrogen ground state energy: -1.137260278. ----- Performing quantum energy estimation by Trotter simulation algorithm Rep #1/5: Energy estimate: -1.16005261648883; Phase estimate: -0.424487268195532 Rep #2/5: Energy estimate: -1.11126176600452; Phase estimate: -0.404970928001809 Rep #3/5: Energy estimate: -1.14194138176224; Phase estimate: -0.417242774304894 Rep #4/5: Energy estimate: -1.12383014703564; Phase estimate: -0.409998280414257 Rep #5/5: Energy estimate: -1.11126176600452; Phase estimate: -0.404970928001809 ----- End Performing quantum energy estimation by Trotter simulation algorithm ----- Performing quantum energy estimation by Qubitization simulation algorithm Rep #1/1: Energy estimate: -1.1347488350418; Phase estimate: -0.581804128657449 ----- End Performing quantum energy estimation by Qubitization simulation algorithm
  • 99. namespace Microsoft.Quantum.Chemistry.Samples.Hydrogen { class Program { static void Main(string[] args) { ////////////////////////////////////////////////////////////////////////// // Introduction ////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////////// // In this example, we will create a spin-orbital representation of the molecular // Hydrogen Hamiltonian `H`, given ovelap coefficients for its one- and // two - electron integrals. // We when perform quantum phase estimation to obtain an estimate of // the molecular Hydrogen ground state energy. #region Building the Hydrogen Hamiltonian through orbital integrals // One of the simplest representations of Hydrogen uses only two // molecular orbitals indexed by `0` and `1`. var nOrbitals = 2; // This representation also has two occupied spin-orbitals. var nElectrons = 2; // The Coulomb repulsion energy between nuclei is var energyOffset = 0.713776188; // One-electron integrals are listed below // <0|H|0> = -1.252477495 // <1|H|1> = -0.475934275 // Two-electron integrals are listed below // <00|H|00> = 0.674493166 // <01|H|01> = 0.181287518 // <01|H|10> = 0.663472101 // <11|H|11> = 0.697398010 • $ psi4 07_h2_sto3g_hf_dumpint 1 electron integral 1 1 -1.25247730398 2 2 -0.475934461144 2 electron integral 1 1 1 1 0.674493103326 1 2 1 2 0.181287535812 2 2 1 1 0.663472044861 2 2 2 2 0.69739794982
  • 100. // We initialize a fermion Hamiltonian data structure and add terms to it var fermionHamiltonian = new OrbitalIntegralHamiltonian(orbitalIntegrals).ToFermionHamiltonian(); // These orbital integral terms are automatically expanded into // spin-orbitals. We may print the Hamiltonian to see verify what it contains. Console.WriteLine("----- Print Hamiltonian"); Console.Write(fermionHamiltonian); Console.WriteLine("----- End Print Hamiltonian n"); // We also need to create an input quantum state to this Hamiltonian. // Let us use the Hartree–Fock state. var fermionWavefunction = fermionHamiltonian.CreateHartreeFockState(nElectrons); #endregion #region Jordan–Wigner representation // The Jordan–Wigner encoding converts the fermion Hamiltonian, // expressed in terms of Fermionic operators, to a qubit Hamiltonian, // expressed in terms of Pauli matrices. This is an essential step // for simulating our constructed Hamiltonians on a qubit quantum // computer. Console.WriteLine("----- Creating Jordan–Wigner encoding"); var jordanWignerEncoding = fermionHamiltonian.ToPauliHamiltonian(Paulis.QubitEncoding.JordanWigner); Console.WriteLine("----- End Creating Jordan–Wigner encoding n"); // Print the Jordan–Wigner encoded Hamiltonian to see verify what it contains. Console.WriteLine("----- Print Hamiltonian"); Console.Write(jordanWignerEncoding); Console.WriteLine("----- End Print Hamiltonian n"); #endregion