Skip to content
Snippets Groups Projects
Verified Commit 6b1e666d authored by Valentin Bruch's avatar Valentin Bruch
Browse files

comparison to experiments: changed figures

parent 4d107733
Branches
No related tags found
No related merge requests found
......@@ -7,6 +7,7 @@ Kondo FRTRG, generate plots for comparison to experiments
"""
import scipy.constants as sc
import pandas as pd
import matplotlib.pyplot as plt
import matplotlib.colors as mplcolors
from matplotlib.widgets import Slider
......@@ -110,6 +111,8 @@ def bruhat18(dm, **parameters):
print("f=19GHz with correction factor 0.89: Vac/omega =\n\t", (0.89*vac_mueV/omega1_mueV).round(6))
print("f=12GHz with correction factor 1.07: Vac/omega =\n\t", (1.07*vac_mueV/omega2_mueV).round(6))
print("Vac max = ", 330 / tkrg_mueV)
print("19GHz: Vac max = ", 410.5 * omega1/omega1_mueV)
print("12GHz: Vac max = ", 410.5 * omega2/omega2_mueV)
print(f"Frequency 19GHz = {omega1_mueV:.6g} μeV")
print(f"Frequency 12GHz = {omega2_mueV:.6g} μeV")
......@@ -271,21 +274,31 @@ def kogan04_calibrate(dm, **kwargs):
#omega = round(omega, 4)
colors = ("red", "green", "blue", "orange", "violet")
#omega = 7.1271
omega = 6
fig, ax = plot_calibration_lines(
omega = 3.5
fig, ax = adjust_background(
dm,
omega = omega,
#omega = 7.418,
vac = np.array([29, 45, 60, 67, 144]) * omega * sc.eV/(13.47e15*sc.h),
colors = colors,
vac_arr = np.array([0.72881, 1.13091, 1.50788, 1.6838, 3.61891])*omega,
xscale = 1/(omega * sc.eV/(13.47e12*sc.h)),
yscale = np.pi,
calibrate_min = 1,
calibrate_max = 1.6,
colors = colors,
include_Ga = True,
integral_method = -15,
**kwargs,
)
#fig, ax = plot_calibration_lines(
# dm,
# omega = omega,
# #omega = 7.418,
# vac = np.array([29, 45, 60, 67, 144]) * omega * sc.eV/(13.47e15*sc.h),
# colors = colors,
# xscale = 1/(omega * sc.eV/(13.47e12*sc.h)),
# yscale = np.pi,
# calibrate_min = 1,
# calibrate_max = 1.6,
# include_Ga = True,
# integral_method = -15,
# **kwargs,
# )
shift_Vdc = 0.017
for i, trace in enumerate((0, 10, 21, 26, 40)):
......@@ -404,6 +417,69 @@ def bruhat18_fig3a(dm, omega_res=250, vac_res=250, **kwargs):
fig.colorbar(img, ax=ax)
return fig, ax
def adjust_background(
dm,
omega,
xscale = 1,
vac_arr = [],
colors = [],
**kwargs):
"""
Plot lines of G vs Vdc for different Vac. A slider can be used to
manipulate the calibration of Vac.
Arguments:
dm: DataManager instance
omega: frequency, in units of Tkrg
vac: list or 1d array of AC voltage, units of Tkrg
colors: list of colors, must have at least same length as vac
xscale: Tkrg to mV, used to scale X axis (Vdc)
vdc_max: max. value of Vdc (units of Tkrg)
vdc_res: resolution of Vdc
**kwargs: parameters for selecting data points
(e.g. voltage_branches, solver_tol_rel, ...)
"""
fig, ax = plt.subplots()
gshift_slider_ax = fig.add_axes((0.1, 0.04, 0.8, 0.02))
gscale_slider_ax = fig.add_axes((0.1, 0.065, 0.8, 0.02))
vdc_shift_slider_ax = fig.add_axes((0.1, 0.09, 0.8, 0.02))
gshift_slider = Slider(gshift_slider_ax, "G shift", 0., 0.2, 0.)
gscale_slider = Slider(gscale_slider_ax, "log10(G scale)", -1.5, 0., 0.)
vdc_shift_slider = Slider(vdc_shift_slider_ax, "Vdc shift", -0.03, 0.03, 0.)
data = dm.list(omega=omega, **kwargs)
# Interpolate
g_arrs = []
vdc_arrs = []
for vac in vac_arr:
data_sel = data[np.abs(data.vac-vac)<1e-6]
g_arrs.append(np.pi*pd.concat((data_sel.dc_conductance, data_sel.dc_conductance)))
vdc_arrs.append(xscale*pd.concat((data_sel.vdc, -data_sel.vdc)))
# Create figure
ax.set_ylabel("G (2e²/h)")
ax.set_xlabel("Vdc")
if colors == []:
colors = len(vac_arr) * ['black']
plot_g = [
ax.plot(vdc, g, 'o', color=color)[0]
for vdc, g, color in zip(vdc_arrs, g_arrs, colors)
]
def update(trash):
gscale = 10**gscale_slider.val
gshift = gshift_slider.val
for i, (vdc, g) in enumerate(zip(vdc_arrs, g_arrs)):
plot_g[i].set_data(vdc+vdc_shift_slider.val, gshift+gscale*g)
gshift_slider.on_changed(update)
gscale_slider.on_changed(update)
vdc_shift_slider.on_changed(update)
fig.sliders = (gshift_slider, gscale_slider, vdc_shift_slider)
return fig, ax
def plot_calibration_lines(
dm,
omega,
......@@ -414,7 +490,7 @@ def plot_calibration_lines(
calibrate_min = 0.8,
calibrate_max = 1.2,
include_i = False,
vdc_max = 50,
vdc_max = 25,
vdc_res = 200,
**kwargs):
"""
......@@ -427,8 +503,8 @@ def plot_calibration_lines(
colors: list of colors, must have at least same length as vac
xscale: Tkrg to mV, used to scale X axis (Vdc)
yscale: G/(e²/2) = π, used to scale Y axis (G)
caibrate_min: start value of the calibration slider
caibrate_max: end value of the calibration slider
calibrate_min: start value of the calibration slider
calibrate_max: end value of the calibration slider
include_i: include G computed from current
vdc_max: max. value of Vdc (units of Tkrg)
vdc_res: resolution of Vdc
......@@ -562,7 +638,7 @@ def kogan04(dm, **parameters):
#omega = round(omega, 5)
#omega = 7.1271
#omega = 7
omega = 6
omega = 3.5
vac_mueV_arr = np.array([29, 45, 60, 67, 144])
vac_omega_arr = vac_mueV_arr / omega_mueV
vac_arr = vac_mueV_arr / tkrg_mueV
......
......@@ -15,7 +15,7 @@ import matplotlib.colors as mplcolors
from matplotlib.widgets import Slider
import argparse
import numpy as np
from scipy.interpolate import bisplrep, bisplev, splrep, BSpline, griddata, interp1d
from scipy.interpolate import bisplrep, bisplev, splrep, splev, BSpline, griddata, interp1d
from scipy.special import jn
from imageio import imwrite
from scipy.integrate import quad, quad_vec
......@@ -883,7 +883,12 @@ def export_kogan04_pgfplots():
In the paper the numbers Tk≃300mK and Ω≃2Tk are given.
These correspond to 7.4182 and 6.8851, respectively.
"""
omega = 6
#omega = 3.1
#xL = 0.05
omega = 3.5
xL = 0.166667
#omega = 4
#xL = 0.1
dm = DataManager()
# adjusted by factor 1.4:
vac_omega = np.array([0.72881, 1.13091, 1.50788, 1.6838, 3.61891])
......@@ -904,22 +909,30 @@ def export_kogan04_pgfplots():
).sort_values(["xL", "vac", "vdc"])
gdc_funcs = []
gdc_funcs_asym = []
prefactor_sym = 0.113*np.pi
prefactor_asym = 0.62*np.pi
g_shift_sym = 0.023
g_shift_asym = 0.022
#prefactor_sym = 0.113*np.pi
#prefactor_asym = 0.62*np.pi
#g_shift_sym = 0.023
#g_shift_asym = 0.022
#prefactor_sym = 0.1*np.pi
#g_shift_sym = 0.015
prefactor_sym = 0.096*np.pi
g_shift_sym = 0.02
#prefactor_sym = 0.0915*np.pi
#g_shift_sym = 0.0245
prefactor_asym = prefactor_sym / (4*xL*(1-xL))
g_shift_asym = g_shift_sym
for v in vac_omega:
data_sel = data[(np.abs(data.xL-0.5) < 1e-6) & (np.abs(data.vac-v*omega)<1e-6)]
try:
gdc_funcs.append(interp1d(data_sel.vdc, g_shift_sym + prefactor_sym*data_sel.dc_conductance, kind="cubic", bounds_error=False))
except ValueError:
gdc_funcs.append(lambda x: np.nan*np.empty_like(x))
data_sel = data[(np.abs(data.xL-0.05) < 1e-6) & (np.abs(data.vac-v*omega)<1e-6)]
data_sel = data[(np.abs(data.xL-xL) < 1e-6) & (np.abs(data.vac-v*omega)<1e-6)]
try:
gdc_funcs_asym.append(interp1d(data_sel.vdc, g_shift_asym + prefactor_asym*data_sel.dc_conductance, kind="cubic", bounds_error=False))
except ValueError:
gdc_funcs_asym.append(lambda x: np.nan*np.empty_like(x))
vdc, *arrays = adjust_argument_array(0, 56, *gdc_funcs, *gdc_funcs_asym, s1=5e-4, maxit=4, initial_resolution=41)
vdc, *arrays = adjust_argument_array(0, 25.5, *gdc_funcs, *gdc_funcs_asym, s1=5e-4, maxit=4, initial_resolution=51)
vdc = np.append(-vdc[:0:-1], vdc)
np.savetxt(
"figdata/kogan04.dat",
......@@ -978,24 +991,40 @@ def export_bruhat18_pgfplots():
except ValueError:
gdc_funcs2.append(lambda x: np.nan*np.empty_like(x))
vdc1, *arrays1 = adjust_argument_array(0, 17.5, *gdc_funcs1, s1=5e-4, maxit=4, initial_resolution=51)
vdc1_asym, *arrays1_asym = adjust_argument_array(0, 17.5, *gdc_funcs1_asym, s1=5e-4, maxit=4, initial_resolution=51)
vdc2, *arrays2 = adjust_argument_array(0, 17.5, *gdc_funcs2, s1=5e-4, maxit=4, initial_resolution=51)
vdc1 = np.append(-vdc1[:0:-1], vdc1)
vdc1_asym = np.append(-vdc1_asym[:0:-1], vdc1_asym)
vdc2 = np.append(-vdc2[:0:-1], vdc2)
vdc1, *arrays1 = adjust_argument_array(0, 21.5, *gdc_funcs1, s1=5e-4, maxit=4, initial_resolution=51)
vdc1_asym, *arrays1_asym = adjust_argument_array(0, 21.5, *gdc_funcs1_asym, s1=5e-4, maxit=4, initial_resolution=51)
vdc2, *arrays2 = adjust_argument_array(0, 21.5, *gdc_funcs2, s1=5e-4, maxit=4, initial_resolution=51)
vdc1 = np.append(-vdc1[:0:-1], vdc1) / omega1
vdc1_asym = np.append(-vdc1_asym[:0:-1], vdc1_asym) / omega1
vdc2 = np.append(-vdc2[:0:-1], vdc2) / omega2
# collect experimental data
#exp_data1 = np.genfromtxt("exp_data/KondoAC_Freq19GHz.dat", names=True)
#vdc_omega_exp1 = exp_data1["Vsd_mV"] * sc.eV/(19e12*sc.h)
#g_exp1_80 = exp_data1["Vac80"]
exp_data2 = np.genfromtxt("exp_data/KondoAC_Freq12GHz.dat", names=True)
vdc_omega_exp2 = exp_data2["Vsd_mV"] * sc.eV/(12e12*sc.h)
g_exp2_20 = exp_data2["Vac20"]
# get background
#g_exp1_bg = g_exp1_80 - gdc_funcs1[0](vdc_omega_exp1*omega1)
g_exp2_bg = g_exp2_20 - gdc_funcs2[0](np.abs(vdc_omega_exp2)*omega2)
sel = ~np.isnan(g_exp2_bg)
g_exp2_bg_spl = splrep(vdc_omega_exp2[sel], g_exp2_bg[sel], s=1e-2)
g2_adiabatic_bg = np.array([quad_vec((lambda t: splev(vdc2+vac*np.cos(t), g_exp2_bg_spl, ext=3)), 0, np.pi)[0]/np.pi for vac in vac_omega2])
g2 = np.array([np.append(a[:0:-1], a) for a in arrays2])
np.savetxt("figdata/bruhat18_19GHz.dat",
np.array([vdc1/omega1, *(np.append(a[:0:-1], a) for a in arrays1)]).T,
np.array([vdc1, *(np.append(a[:0:-1], a) for a in arrays1)]).T,
header = "vdc " + " ".join(f"g{v:.3g}" for v in vac_omega1),
fmt = "%.6g",
comments = "")
np.savetxt("figdata/bruhat18_12GHz.dat",
np.array([vdc2/omega2, *(np.append(a[:0:-1], a) for a in arrays2)]).T,
header = "vdc " + " ".join(f"g{v:.3g}" for v in vac_omega2),
np.array([vdc2, *g2, *g2_adiabatic_bg, *(g2 + g2_adiabatic_bg)]).T,
header = "vdc " + " ".join(f"g{v:.3g}" for v in vac_omega2) + " " + " ".join(f"bg{v:.3g}" for v in vac_omega2) + " " + " ".join(f"gbg{v:.3g}" for v in vac_omega2),
fmt = "%.6g",
comments = "")
np.savetxt("figdata/bruhat18_19GHz_asym.dat",
np.array([vdc1_asym/omega1, *(np.append(a[:0:-1], a) for a in arrays1_asym)]).T,
np.array([vdc1_asym, *(np.append(a[:0:-1], a) for a in arrays1_asym)]).T,
header = "vdc " + " ".join(f"g{v:.3g}" for v in vac_omega1),
fmt = "%.6g",
comments = "")
......
......@@ -7,24 +7,24 @@
\definecolor{ac}{rgb}{.5,.5,.5}%
\definecolor{green}{rgb}{0,.67,0}%
\pgfplotsset{adiabatic style/.style={densely dotted, thick, color=adiabatic}}%
\pgfplotsset{frtrg style/.style={solid, line width=0.8pt, color=frtrg, no marks}}%
\pgfplotsset{frtrg style/.style={solid, line width=0.75pt, color=frtrg, no marks}}%
\pgfplotsset{phenomenological style/.style={color=phenomenological}}%
\pgfplotsset{ac style/.style={thick, dashdotted, color=ac}}%
\pgfplotsset{analytic style/.style={thick, densely dashed}}%
\definecolor{c02}{rgb}{0,0,0}%
\definecolor{c04}{rgb}{.5,0,0}%
\definecolor{c06}{rgb}{.9,0,0}%
\definecolor{c02}{rgb}{.5,.5,.5}%
\definecolor{c04}{rgb}{.65,.08,.08}%
\definecolor{c06}{rgb}{.95,.1,0}%
\definecolor{c08}{rgb}{.9,.5,0}%
\definecolor{c10}{rgb}{.5,.7,0}%
\definecolor{c12}{rgb}{0,.45,0}%
\definecolor{c14}{rgb}{0,.8,.4}%
\definecolor{c16}{rgb}{0,.5,.7}%
\definecolor{c20}{rgb}{0,0,1}%
\definecolor{c18}{rgb}{0,0,.5}%
\definecolor{c22}{rgb}{.5,0,.8}%
\definecolor{c12}{rgb}{0,.6,0}%
\definecolor{c14}{rgb}{0,.8,.5}%
\definecolor{c16}{rgb}{0,.6,.7}%
\definecolor{c18}{rgb}{.3,.25,1}%
\definecolor{c20}{rgb}{.05,.05,.6}%
\definecolor{c22}{rgb}{.6,0,1}%
\definecolor{c24}{rgb}{.7,0,.3}%
\definecolor{c30}{rgb}{.1,0,.1}%
\newcommand\plotsep{0.04}
\definecolor{c30}{rgb}{.9,0,1}%
\newcommand\plotsep{0.04}%
%\tikzsetnextfilename{bruhat18}%
\begin{tikzpicture}
\begin{axis}[
......@@ -32,8 +32,8 @@
ymin = 0.13, ymax = 0.75,
xmin = -4.957, xmax = 5.225,
mark = *,
width = 6.5cm,
height = 12cm,
width = 6.52cm,
height = 13cm,
scale only axis,
xlabel = {$\vdc~(\Omega)$},
ylabel = {$\gdc~(2e^2/h)$},
......@@ -42,31 +42,66 @@
xtick distance = 2,
minor x tick num = 1,
legend entries = {
{\hspace*{-1.6em}\rlap{$\vac~(\mu V)$}}, {\null},
20, 40, 60, 80, 100, 120, 160, 180, 200, 220, 240, 300
{\clap{$\vac~(\mu V)$}}, {\null},
20, 40, 60, 80, 100, 120, 140, 160, 180, 200, 220, 240, {\null}, 300
},
legend cell align = right,
legend columns = 2,
legend style = {
at = {(axis description cs:1,1)},
anchor = north east,
xshift = -4pt,
yshift = -4pt,
xshift = -5pt,
yshift = -5pt,
draw = none,
fill = none,
},
legend image code/.code = {%
\draw[#1]%
plot coordinates {%
(0.5mm,0mm)
(5mm,0mm)
};%
}%
]
\node[black] at (axis description cs:0.25,0.9) {$f=19\,\mathrm{GHz}$};
\addlegendimage{empty legend};
\addlegendimage{empty legend};
%
\addplot[frtrg style, on layer=main, color=c02] coordinates {(9,0) (10,0)};
\addplot[frtrg style, on layer=main, color=c04] coordinates {(9,0) (10,0)};
\addplot[frtrg style, on layer=main, color=c06] coordinates {(9,0) (10,0)};
%
\addplot[only marks, on layer=main, color=c08, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac80} + 9*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.906} + 9*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c08] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.906} + 9*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[only marks, on layer=main, color=c10, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac100} + 8*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.13} + 8*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c10] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.13} + 8*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[only marks, on layer=main, color=c12, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac120} + 7*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.36} + 7*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c12] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.36} + 7*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[only marks, on layer=main, color=c14, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac140} + 6*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.59} + 6*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c14] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.59} + 6*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[only marks, on layer=main, color=c16, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac160} + 5*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.81} + 5*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c16] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.81} + 5*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[only marks, on layer=main, color=c18, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac180} + 4*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.04} + 4*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c18] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.04} + 4*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[only marks, on layer=main, color=c20, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac200} + 3*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.27} + 3*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c20] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.27} + 3*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[only marks, on layer=main, color=c22, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac220} + 2*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.49} + 2*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c22] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.49} + 2*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[only marks, on layer=main, color=c24, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac240} + 1*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.72} + 1*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c24] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.72} + 1*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addlegendimage{empty legend};
\addplot[only marks, on layer=main, color=c30, forget plot] table[x expr={12.7263*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac300} + 0*\plotsep}] {../exp_data/KondoAC_Freq19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.4} + 0*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c30] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.4} + 0*\plotsep}] {../figdata/bruhat18_19GHz.dat};
%
%\addplot[frtrg style, cyan, on layer=main, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.906} + 9*\plotsep}] {../figdata/bruhat18_19GHz_asym.dat};
%\addplot[frtrg style, cyan, on layer=main, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.13} + 8*\plotsep}] {../figdata/bruhat18_19GHz_asym.dat};
......@@ -78,42 +113,17 @@
%\addplot[frtrg style, cyan, on layer=main, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.49} + 2*\plotsep}] {../figdata/bruhat18_19GHz_asym.dat};
%\addplot[frtrg style, cyan, on layer=main, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.72} + 1*\plotsep}] {../figdata/bruhat18_19GHz_asym.dat};
%\addplot[frtrg style, cyan, on layer=main, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.4} + 0*\plotsep}] {../figdata/bruhat18_19GHz_asym.dat};
%
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.906} + 9*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.13} + 8*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.36} + 7*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.59} + 6*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.81} + 5*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.04} + 4*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.27} + 3*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.49} + 2*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.72} + 1*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.4} + 0*\plotsep}] {../figdata/bruhat18_19GHz.dat};
%
\addplot[frtrg style, on layer=main, color=c02] coordinates {(9,0) (10,0)};
\addplot[frtrg style, on layer=main, color=c04] coordinates {(9,0) (10,0)};
\addplot[frtrg style, on layer=main, color=c06] coordinates {(9,0) (10,0)};
\addplot[frtrg style, on layer=main, color=c08] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.906} + 9*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c10] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.13} + 8*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c12] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.36} + 7*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c14] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.59} + 6*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c16] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.81} + 5*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c18] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.04} + 4*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c20] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.27} + 3*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c22] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.49} + 2*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c24] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.72} + 1*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\addplot[frtrg style, on layer=main, color=c30] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.4} + 0*\plotsep}] {../figdata/bruhat18_19GHz.dat};
\end{axis}
\begin{axis}[
name = 12GHz,
at = (19GHz.east),
anchor = west,
xshift = 0.75em,
xshift = 0.8em,
ymin = 0.13, ymax = 0.75,
xmin = -7.849, xmax = 8.272,
mark = *,
width = 6.5cm,
height = 12cm,
width = 6.52cm,
height = 13cm,
scale only axis,
xlabel = {$\vdc~(\Omega)$},
xtick distance = 2,
......@@ -125,41 +135,51 @@
\node[black] at (axis description cs:0.25,0.9) {$f=12\,\mathrm{GHz}$};
%
\addplot[only marks, on layer=main, color=c02, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac20} + 10*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c04, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac40} + 9*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c06, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac60} + 8*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c08, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac80} + 7*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c10, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac100} + 6*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c12, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac120} + 5*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c14, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac140} + 4*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c16, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac160} + 3*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c18, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac180} + 2*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c22, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac220} + 1*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[only marks, on layer=main, color=c30, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac300} + 0*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
%
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.431} +10*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.862} + 9*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.29} + 8*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.72} + 7*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.16} + 6*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.59} + 5*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.02} + 4*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.45} + 3*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.88} + 2*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g4.74} + 1*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g6.47} + 0*\plotsep}] {../figdata/bruhat18_12GHz.dat};
%
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.431} +10*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c02] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.431} +10*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[only marks, on layer=main, color=c04, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac40} + 9*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.862} + 9*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c04] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g0.862} + 9*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[only marks, on layer=main, color=c06, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac60} + 8*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.29} + 8*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c06] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.29} + 8*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[only marks, on layer=main, color=c08, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac80} + 7*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.72} + 7*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c08] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g1.72} + 7*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[only marks, on layer=main, color=c10, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac100} + 6*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.16} + 6*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c10] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.16} + 6*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[only marks, on layer=main, color=c12, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac120} + 5*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.59} + 5*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c12] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g2.59} + 5*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[only marks, on layer=main, color=c14, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac140} + 4*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.02} + 4*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c14] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.02} + 4*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[only marks, on layer=main, color=c16, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac160} + 3*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.45} + 3*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c16] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.45} + 3*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[only marks, on layer=main, color=c18, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac180} + 2*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.88} + 2*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c18] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g3.88} + 2*\plotsep}] {../figdata/bruhat18_12GHz.dat};
%\addplot[frtrg style, on layer=main, color=c20] coordinates {(9,0) (10,0)};
\addplot[only marks, on layer=main, color=c22, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac220} + 1*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g4.74} + 1*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c22] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g4.74} + 1*\plotsep}] {../figdata/bruhat18_12GHz.dat};
%\addplot[frtrg style, on layer=main, color=c24] coordinates {(9,0) (10,0)};
\addplot[only marks, on layer=main, color=c30, forget plot] table[x expr={20.1499*\thisrow{Vsd_mV}}, y expr={\thisrow{Vac300} + 0*\plotsep}] {../exp_data/KondoAC_Freq12GHz.dat};
\addplot[frtrg style, on layer=main, color=white, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g6.47} + 0*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=c30] table[x expr={\thisrow{vdc}}, y expr={\thisrow{g6.47} + 0*\plotsep}] {../figdata/bruhat18_12GHz.dat};
%
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg0.431} +10*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg0.862} + 9*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg1.29} + 8*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg1.72} + 7*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg2.16} + 6*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg2.59} + 5*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg3.02} + 4*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg3.45} + 3*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg3.88} + 2*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg4.74} + 1*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\addplot[frtrg style, on layer=main, color=black, line width=0.6pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gbg6.47} + 0*\plotsep}] {../figdata/bruhat18_12GHz.dat};
\end{axis}
\end{tikzpicture}
......@@ -7,52 +7,102 @@
\definecolor{ac}{rgb}{.5,.5,.5}%
\definecolor{green}{rgb}{0,.67,0}%
\pgfplotsset{adiabatic style/.style={densely dotted, thick, color=adiabatic}}%
\pgfplotsset{frtrg style/.style={solid, thick, color=frtrg}}%
\pgfplotsset{frtrg style/.style={solid, line width=0.75pt, color=frtrg, no marks}}%
\pgfplotsset{phenomenological style/.style={color=phenomenological}}%
\pgfplotsset{ac style/.style={thick, dashdotted, color=ac}}%
\pgfplotsset{analytic style/.style={thick, densely dashed}}%
\definecolor{c02}{rgb}{.5,.5,.5}%
\definecolor{c04}{rgb}{.65,.08,.08}%
\definecolor{c06}{rgb}{.95,.1,0}%
\definecolor{c08}{rgb}{.9,.5,0}%
\definecolor{c10}{rgb}{.5,.7,0}%
\definecolor{c12}{rgb}{0,.6,0}%
\definecolor{c14}{rgb}{0,.8,.5}%
\definecolor{c16}{rgb}{0,.6,.7}%
\definecolor{c18}{rgb}{.3,.25,1}%
\definecolor{c20}{rgb}{.05,.05,.6}%
\definecolor{c22}{rgb}{.6,0,1}%
\definecolor{c24}{rgb}{.7,0,.3}%
\definecolor{c30}{rgb}{.9,0,1}%
\newcommand\plotsep{0.02}%
%\tikzsetnextfilename{kogan04}%
\begin{tikzpicture}
\begin{axis}[
ymin = 0.04, ymax = 0.208,
xmin = -7.2, xmax = 7.2,
%ymin = 0.037, ymax = 0.205,
ymin = 0.037, ymax = 0.188,
xmin = -7.3, xmax = 6.7,
mark = *,
width = 9cm,
height = 6cm,
height = 8cm,
scale only axis,
xlabel = {$\vdc~(\Omega)$},
ylabel = {$\gdc~(2e^2/h)$},
ytick = {0.05, 0.1, 0.15, 0.2},
yticklabels = {$0.05$, $0.1$, $0.15$, $0.2$},
%ytick = {0.05, 0.1, 0.15, 0.2},
%yticklabels = {$0.05$, $0.1$, $0.15$, $0.2$},
yticklabel style = {/pgf/number format/.cd,fixed,precision=2},
mark size = 0.4pt,
clip marker paths = true,
xtick distance = 2,
minor x tick num = 1,
legend entries = {
{\hspace*{-1.8em}{$\vac~(\mu V)$}},
\hphantom{1}29, \hphantom{1}45, \hphantom{1}60, \hphantom{1}67, 144,
$x_L=x_R$\vphantom{1}
},
%legend columns = 2,
legend cell align = left,
legend style = {
at = {(axis description cs:0,1)},
anchor = north west,
xshift = 14pt,
yshift = -4pt,
draw = none,
fill = none,
},
legend image code/.code = {%
\draw[#1]%
plot coordinates {%
(0.5mm,0mm)
(5mm,0mm)
};%
}%
]
\addplot[only marks, on layer=main, color=experiment] table[x expr={17.95*\thisrowno{1}}, y expr={\thisrowno{0}/2+0.08}] {../exp_data/d764n766_didv_trace0++.txt};
\addplot[only marks, on layer=main, color=experiment] table[x expr={17.95*\thisrowno{1}}, y expr={\thisrowno{0}/2+0.06}] {../exp_data/d764n766_didv_trace10++.txt};
\addplot[only marks, on layer=main, color=experiment] table[x expr={17.95*\thisrowno{1}}, y expr={\thisrowno{0}/2+0.04}] {../exp_data/d764n766_didv_trace21++.txt};
\addplot[only marks, on layer=main, color=experiment] table[x expr={17.95*\thisrowno{1}}, y expr={\thisrowno{0}/2+0.02}] {../exp_data/d764n766_didv_trace26++.txt};
\addplot[only marks, on layer=main, color=experiment] table[x expr={17.95*\thisrowno{1}}, y expr={\thisrowno{0}/2+0.00}] {../exp_data/d764n766_didv_trace40++.txt};
\addlegendimage{empty legend};
\addplot[only marks, on layer=main, color=c06, forget plot] table[x expr={17.95*\thisrowno{1}-0.3}, y expr={\thisrowno{0}/2 + 4*\plotsep}] {../exp_data/d764n766_didv_trace0++.txt};
\addplot[only marks, on layer=main, color=c08, forget plot] table[x expr={17.95*\thisrowno{1}-0.3}, y expr={\thisrowno{0}/2 + 3*\plotsep}] {../exp_data/d764n766_didv_trace10++.txt};
\addplot[only marks, on layer=main, color=c12, forget plot] table[x expr={17.95*\thisrowno{1}-0.3}, y expr={\thisrowno{0}/2 + 2*\plotsep}] {../exp_data/d764n766_didv_trace21++.txt};
\addplot[only marks, on layer=main, color=c16, forget plot] table[x expr={17.95*\thisrowno{1}-0.3}, y expr={\thisrowno{0}/2 + 1*\plotsep}] {../exp_data/d764n766_didv_trace26++.txt};
\addplot[only marks, on layer=main, color=c22, forget plot] table[x expr={17.95*\thisrowno{1}-0.3}, y expr={\thisrowno{0}/2 + 0*\plotsep}] {../exp_data/d764n766_didv_trace40++.txt};
%
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g0.754asym}+0.16}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.17asym}+0.12}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.56asym}+0.08}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.74asym}+0.04}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g3.74asym}+0.00}] {../figdata/kogan04.dat};
\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g0.729asym}+0.08}] {../figdata/kogan04.dat};
\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.13asym}+0.06}] {../figdata/kogan04.dat};
\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.51asym}+0.04}] {../figdata/kogan04.dat};
\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.68asym}+0.02}] {../figdata/kogan04.dat};
\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g3.62asym}+0.00}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x={vdc}, y expr={\thisrow{g0.754asym}+ 4*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x={vdc}, y expr={\thisrow{g1.17asym} + 3*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x={vdc}, y expr={\thisrow{g1.56asym} + 2*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x={vdc}, y expr={\thisrow{g1.74asym} + 1*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x={vdc}, y expr={\thisrow{g3.74asym} + 0*\plotsep}] {../figdata/kogan04.dat};
% asymmetry:
\addplot[frtrg style, black, line width=0.6pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g0.729}+ 4*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, black, line width=0.6pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g1.13} + 3*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, black, line width=0.6pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g1.51} + 2*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, black, line width=0.6pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g1.68} + 1*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, black, line width=0.6pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g3.62} + 0*\plotsep}] {../figdata/kogan04.dat};
%
%\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g0.754}+0.16}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.17}+0.12}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.56}+0.08}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.74}+0.04}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g3.74}+0.00}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g0.729}+0.08}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.13}+0.06}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.51}+0.04}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.68}+0.02}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g3.62}+0.00}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x={vdc}, y expr={\thisrow{g0.729asym}+ 4*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x={vdc}, y expr={\thisrow{g1.13asym} + 3*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x={vdc}, y expr={\thisrow{g1.51asym} + 2*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x={vdc}, y expr={\thisrow{g1.68asym} + 1*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x={vdc}, y expr={\thisrow{g3.62asym} + 0*\plotsep}] {../figdata/kogan04.dat};
%
%\addplot[frtrg style, on layer=main] table[x={vdc}, y expr={\thisrow{g0.754}+ 4*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x={vdc}, y expr={\thisrow{g1.17} + 3*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x={vdc}, y expr={\thisrow{g1.56} + 2*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x={vdc}, y expr={\thisrow{g1.74} + 1*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x={vdc}, y expr={\thisrow{g3.74} + 0*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c06] table[x={vdc}, y expr={\thisrow{g0.729asym}+ 4*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c08] table[x={vdc}, y expr={\thisrow{g1.13asym} + 3*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c12] table[x={vdc}, y expr={\thisrow{g1.51asym} + 2*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c16] table[x={vdc}, y expr={\thisrow{g1.68asym} + 1*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c22] table[x={vdc}, y expr={\thisrow{g3.62asym} + 0*\plotsep}] {../figdata/kogan04.dat};
%
\addplot[frtrg style, black, line width=0.5pt] coordinates {(8,0) (9,0)};
\end{axis}
\end{tikzpicture}
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Please register or to comment