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

plots: small improvements, I(Λ0) convergence

parent 220dbaf2
Branches
No related tags found
No related merge requests found
......@@ -19,13 +19,14 @@ from scipy.interpolate import bisplrep, bisplev, splrep, splev, BSpline, griddat
from scipy.special import jn
from imageio import imwrite
from scipy.integrate import quad, quad_vec
from scipy.optimize import newton
from scipy.optimize import newton, curve_fit, leastsq
import settings
from data_management import DataManager, KondoImport
from kondo import gen_init_matrix
from numbers import Number
from gen_pulse_data import fourier_coef_gauss_symmetric
from plot_pulses import load_all_pulses_full, integrate_ft
from kondo import solveTV0_scalar
# In this program all energies are given in units of the RTRG Kondo
# temperature Tkrg, which is an integration constant of the E-flow RG
......@@ -888,7 +889,7 @@ def export_kogan04_pgfplots():
omega = 3.5
xL = 0.166667
#omega = 4
#xL = 0.1
#xL = 0.2
dm = DataManager()
# adjusted by factor 1.4:
vac_omega = np.array([0.72881, 1.13091, 1.50788, 1.6838, 3.61891])
......@@ -915,8 +916,12 @@ def export_kogan04_pgfplots():
#g_shift_asym = 0.022
#prefactor_sym = 0.1*np.pi
#g_shift_sym = 0.015
# for omega=3.5, xL=0.166667:
prefactor_sym = 0.096*np.pi
g_shift_sym = 0.02
# for omega=4, xL=0.2:
#prefactor_sym = 0.093*np.pi
#g_shift_sym = 0.024
#prefactor_sym = 0.0915*np.pi
#g_shift_sym = 0.0245
prefactor_asym = prefactor_sym / (4*xL*(1-xL))
......@@ -947,7 +952,7 @@ def export_kogan04_pgfplots():
def export_bruhat18_pgfplots(
plot_s = 1e-3,
plot_s = 2e-3,
init_res = 41,
):
dm = DataManager()
......@@ -1093,26 +1098,29 @@ def export_pulse_current_pgfplots(omega=1.5, pulse_duration=0.01):
np.linspace(0.08/t_prefactor, 0.5/t_prefactor, 42, endpoint=False),
np.linspace(0.5/t_prefactor, 3.33/t_prefactor, 40, endpoint=False),
np.linspace(3.33/t_prefactor, 0.49, 41)))
vdc, fourier_coef = fourier_coef_gauss_symmetric(1000, omega, pulse_duration, None, 1)
u = vdc + 2*sum((np.exp(-2j*np.pi*t*n)*c).real for n,c in enumerate(fourier_coef, 1))
u /= u.max()
i_arrs = [-coef[0].real + 2*sum((np.exp(-2j*np.pi*t*n)*c).real for n,c in enumerate(coef)) for coef in i_coef]
g_arrs = [-coef[0].real + 2*sum((np.exp(-2j*np.pi*t*n)*c).real for n,c in enumerate(coef)) for coef in g_coef]
t *= t_prefactor
array = np.array([t, *i_arrs, *g_arrs]).T
array = np.array([t, u, *i_arrs, *g_arrs]).T
np.savetxt("figdata/pulse_current_full.dat",
array,
header = "t " + " ".join(f"i{i}" for i in range(1,5)) + " " + " ".join(f"g{i}" for i in range(1,5)),
header = "t u " + " ".join(f"i{i}" for i in range(1,5)) + " " + " ".join(f"g{i}" for i in range(1,5)),
fmt = "%.6g",
comments = "")
np.savetxt("figdata/pulse_current_zoom.dat",
array[10:141],
header = "t " + " ".join(f"i{i}" for i in range(1,5)) + " " + " ".join(f"g{i}" for i in range(1,5)),
header = "t u " + " ".join(f"i{i}" for i in range(1,5)) + " " + " ".join(f"g{i}" for i in range(1,5)),
fmt = "%.6g",
comments = "")
np.savetxt("figdata/pulse_current_tail.dat",
array[140:223],
header = "t " + " ".join(f"i{i}" for i in range(1,5)) + " " + " ".join(f"g{i}" for i in range(1,5)),
header = "t u " + " ".join(f"i{i}" for i in range(1,5)) + " " + " ".join(f"g{i}" for i in range(1,5)),
fmt = "%.6g",
comments = "")
......@@ -1325,20 +1333,37 @@ def export_harmonic_modes(
plt.show()
def export_convergence_pgfplots(omega = 16.5372):
def export_convergence_pgfplots(simplified_initial_conditions = False):
"""
Plot convergence of current as function of D (Λ₀) for a fine
grid of dc and ac voltage at fixed omega.
"""
dm = DataManager()
assert isinstance(parameters["omega"], Number)
parameters = dict(
omega = 16.5372,
method = "mu",
include_Ga = True,
voltage_branches = 4,
integral_method = -15,
solver_tol_rel = 1e-9,
solver_tol_abs = 1e-11,
xL = 0.5,
bad_flags = DataManager.SOLVER_FLAGS["simplified_initial_conditions"] \
| DataManager.SOLVER_FLAGS["second_order_rg_equations"] \
| DataManager.SOLVER_FLAGS["solve_integral_exactly"] \
| DataManager.SOLVER_FLAGS["extrapolate_voltage"] \
| DataManager.SOLVER_FLAGS["deleted"],
good_flags = DataManager.SOLVER_FLAGS["include_Ga"],
)
if simplified_initial_conditions:
parameters["good_flags"] ^= DataManager.SOLVER_FLAGS["simplified_initial_conditions"]
parameters["bad_flags"] ^= DataManager.SOLVER_FLAGS["simplified_initial_conditions"]
vac_num = 26
vdc_num = 26
vdc_max = 82.686
vac_max = 82.686
bad_flags = 0x0c84
good_flags = 0x1008
exponent = 2 if good_flags & 8 else 3
exponent = 2 if parameters["good_flags"] & DataManager.SOLVER_FLAGS["simplified_initial_conditions"] else 3
d_num = 5
log10d_min = 5
log10d_max = 9
......@@ -1368,15 +1393,30 @@ def export_convergence_pgfplots(omega = 16.5372):
(iac_fit_a[i,j], iac_fit_b[i,j]), trash = leastsq(fit_func, (iac[-1,i,j], 0.), args=(iac[:,i,j]))
extent = (-0.5*vdc_max/(vdc_num-1), vdc_max*(1+0.5/(vdc_num-1)), -0.5*vac_max/(vac_num-1), vac_max*(1+0.5/(vac_num-1)))
idc_diff = (abs(idc_fit_a) > 1e-6) * (((idc_fit_a.reshape((1,vac_num,vdc_num)) + idc_fit_b.reshape((1,vac_num,vdc_num))*logd_inv3.reshape((d_num,1,1)) - idc)**2).sum(axis=0)/d_num)**0.5 / (idc_fit_b * logd_inv3[-1])
iac_diff = (abs(iac_fit_a) > 1e-6) * (((iac_fit_a.reshape((1,vac_num,vdc_num)) + iac_fit_b.reshape((1,vac_num,vdc_num))*logd_inv3.reshape((d_num,1,1)) - iac)**2).sum(axis=0)/d_num)**0.5 / (iac_fit_b * logd_inv3[-1])
gdc_diff = (((gdc_fit_a.reshape((1,vac_num,vdc_num)) + gdc_fit_b.reshape((1,vac_num,vdc_num))*logd_inv3.reshape((d_num,1,1)) - gdc)**2).sum(axis=0)/d_num)**0.5 / (gdc_fit_b * logd_inv3[-1])
img = ax1.imshow(idc_fit_a, extent=extent, origin="lower")
img = ax2.imshow((abs(idc_fit_a)>1e-6)*idc_fit_b*(-logd_inv3[4])/idc_fit_a, extent=extent, origin="lower")
img = ax3.imshow(-idc_diff, extent=extent, origin="lower")
img = ax4.imshow(iac_fit_a, extent=extent, origin="lower")
img = ax5.imshow((abs(iac_fit_a)>1e-6)*iac_fit_b*(-logd_inv3[4])/iac_fit_a, extent=extent, origin="lower")
img = ax6.imshow(-iac_diff, extent=extent, origin="lower")
#extent_dc = (0.5*vdc_max/(vdc_num-1), vdc_max*(1+0.5/(vdc_num-1)), -0.5*vac_max/(vac_num-1), vac_max*(1+0.5/(vac_num-1)))
#extent_ac = (-0.5*vdc_max/(vdc_num-1), vdc_max*(1+0.5/(vdc_num-1)), 0.5*vac_max/(vac_num-1), vac_max*(1+0.5/(vac_num-1)))
print(f"Extent: xmin={extent[0]/TK_VOLTAGE:.6g}, xmax={extent[1]/TK_VOLTAGE:,.6g}, ymin={extent[2]/TK_VOLTAGE:.6g}, ymax={extent[3]/TK_VOLTAGE:,.6g}")
#print(f"Extent: xmin={extent_dc[0]/TK_VOLTAGE:.6g}, xmax={extent_dc[1]/TK_VOLTAGE:,.6g}, ymin={extent_dc[2]/TK_VOLTAGE:.6g}, ymax={extent_dc[3]/TK_VOLTAGE:,.6g}")
#print(f"Extent: xmin={extent_ac[0]/TK_VOLTAGE:.6g}, xmax={extent_ac[1]/TK_VOLTAGE:,.6g}, ymin={extent_ac[2]/TK_VOLTAGE:.6g}, ymax={extent_ac[3]/TK_VOLTAGE:,.6g}")
suffix = "_bad" if simplified_initial_conditions else "_good"
def export_img(name, array):
imwrite(f"figdata/{name}{suffix}.png", np.array(0xffff*plt.cm.viridis(array[::-1])[...,:3], dtype=np.uint16), format="PNG-FI")
idc_max = np.nanmax(idc_fit_a)
iac_max = np.nanmax(iac_fit_a)
i_max = max(idc_max, 2*iac_max)
export_img("idc_converged", idc_fit_a/i_max)
export_img("iac_converged", iac_fit_a*(2/i_max))
print(f"I range: 0, {i_max/TK_VOLTAGE:.6g}")
idc_diff = (idc_fit_b*(-logd_inv3[4])/idc_fit_a)[:,1:]
iac_diff = (iac_fit_b*(-logd_inv3[4])/iac_fit_a)[1:]
idc_diff_max = np.nanmax(idc_diff)
iac_diff_max = np.nanmax(iac_diff)
i_diff_max = max(idc_diff_max, iac_diff_max)
export_img("idc_diff", idc_diff/i_diff_max)
export_img("iac_diff", iac_diff/i_diff_max)
print(f"I diff range: 0, {i_diff_max:.6g}")
......
......@@ -19,12 +19,12 @@
},
legend cell align = left,
legend entries = {
$x_L=10^{-3}$,
$x_L=0.1$,
$x_L=0.2$,
$x_L=0.3$,
$x_L=0.4$,
$x_L=0.5$,
$x_R=10^{-3}$,
$x_R=0.1$,
$x_R=0.2$,
$x_R=0.3$,
$x_R=0.4$,
$x_R=0.5$,
},
]
\addplot[red] table [x=vdc, y={xL0.001}] {../figdata/asymmetry.dat};
......
......@@ -12,18 +12,18 @@
\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{c04}{rgb}{.7,.25,.35}%
\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}%
\definecolor{c10}{rgb}{.67,.54,0}%
\definecolor{c12}{rgb}{.5,.75,0}%
\definecolor{c14}{rgb}{0,.62,0}%
\definecolor{c16}{rgb}{0,.8,.5}%
\definecolor{c18}{rgb}{0,.6,.7}%
\definecolor{c20}{rgb}{.25,.3,1}%
\definecolor{c22}{rgb}{.6,.35,.9}%
\definecolor{c24}{rgb}{.9,0,1}%
\definecolor{c30}{rgb}{.8,.25,.6}%
\definecolor{lightgray}{rgb}{.6,.6,.6}%
\newcommand\plotsep{0.04}%
%\tikzsetnextfilename{bruhat18}%
......@@ -59,8 +59,8 @@
legend image code/.code = {%
\draw[#1]%
plot coordinates {%
(0.5mm,0mm)
(5mm,0mm)
(1mm,0mm)
(5.5mm,0mm)
};%
}%
]
......@@ -158,39 +158,39 @@
\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[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=white, opacity=0.8, 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=white, opacity=0.8, 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=white, opacity=0.8, 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=white, opacity=0.8, 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=white, opacity=0.8, 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=white, opacity=0.8, 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=white, opacity=0.8, 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=white, opacity=0.8, 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=white, opacity=0.8, 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=white, opacity=0.8, 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=white, opacity=0.8, 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=lightgray, line width=0.4pt, forget plot] table[x expr={\thisrow{vdc}}, y expr={\thisrow{gpatbg0.431} +10*\plotsep}] {../figdata/bruhat18_12GHz.dat};
......
\begin{tikzpicture}
\begin{axis}[
name = idc,
title = $I_\mathrm{avg}$,
title style = {yshift = -2mm},
height = 4.5cm,
width = 4.5cm,
scale only axis,
xmin = -0.5, xmax = 24.5,
ymin = -0.5, ymax = 24.5,
xticklabels = {},
ylabel = $\vac~(k_B \tkv/e)$,
axis on top,
]
\addplot graphics[xmin=-0.480379, xmax=24.4993, ymin=-0.480379, ymax=24.4993] {../figdata/idc_converged_good.png};
\end{axis}
\begin{axis}[
name = iac,
at = (idc.east),
anchor = west,
title = $I_\mathrm{osc}$,
title style = {yshift = -2mm},
xshift = 4mm,
height = 4.5cm,
width = 4.5cm,
scale only axis,
xmin = -0.5, xmax = 24.5,
ymin = -0.5, ymax = 24.5,
xticklabels = {},
yticklabels = {},
axis on top,
]
\addplot graphics[xmin=-0.480379, xmax=24.4993, ymin=-0.480379, ymax=24.4993] {../figdata/iac_converged_good.png};
\end{axis}
\begin{axis}[
name = idc_diff,
at = (idc.south),
anchor = north,
yshift = -9mm,
title = {$|I_\mathrm{avg}(\Lambda_0=10^9\tkrg) - I_\mathrm{avg}|/I_\mathrm{avg}$},
title style = {yshift = -2mm},
height = 4.5cm,
width = 4.5cm,
scale only axis,
xmin = -0.5, xmax = 24.5,
ymin = -0.5, ymax = 24.5,
xlabel = $\vdc~(k_B \tkv/e)$,
ylabel = $\vac~(k_B \tkv/e)$,
axis on top,
]
\addplot graphics[xmin=0.480379, xmax=24.4993, ymin=-0.480379, ymax=24.4993] {../figdata/idc_diff_good.png};
\end{axis}
\begin{axis}[
name = iac_diff,
at = (idc_diff.east),
anchor = west,
xshift = 4mm,
title = {$|I_\mathrm{osc}(\Lambda_0=10^9\tkrg) - I_\mathrm{osc}|/I_\mathrm{osc}$},
title style = {yshift = -2mm},
height = 4.5cm,
width = 4.5cm,
scale only axis,
xmin = -0.5, xmax = 24.5,
ymin = -0.5, ymax = 24.5,
xlabel = $\vdc~(k_B \tkv/e)$,
yticklabels = {},
axis on top,
]
\addplot graphics[xmin=-0.480379, xmax=24.4993, ymin=0.480379, ymax=24.4993] {../figdata/iac_diff_good.png};
\end{axis}
%
\begin{axis}[
name = colorbar,
at = (iac.east),
anchor = west,
ymin = 0,
ymax = 1.54775,
xshift = 5mm,
enlargelimits = false,
axis on top,
width = .75em,
height = 4.5cm,
scale only axis,
tickpos = right,
tick align = outside,
xtick = \empty,
ylabel = {current $(e k_B \tkv/\hbar)$},
]
\addplot graphics[xmin=0, xmax=1, ymin=0, ymax=1.54775] {../figdata/colorbar_viridis.png};
\end{axis}
\begin{axis}[
name = colorbar,
at = (iac_diff.east),
anchor = west,
ymin = 0,
ymax = 0.00469774,
xshift = 5mm,
enlargelimits = false,
axis on top,
width = .75em,
height = 4.5cm,
scale only axis,
tickpos = right,
tick align = outside,
xtick = \empty,
ytick = {0, 0.002, 0.004},
yticklabels = {$0$, $0.2\%$, $0.4\%$},
scaled ticks = false,
ylabel = {relative deviation},
]
\addplot graphics[xmin=0, xmax=1, ymin=0, ymax=0.00469774] {../figdata/colorbar_viridis.png};
\end{axis}
\end{tikzpicture}
\begin{tikzpicture}
\begin{axis}[
name = idc,
title = $I_\mathrm{avg}$,
title style = {yshift = -2mm},
height = 4.5cm,
width = 4.5cm,
scale only axis,
xmin = -0.5, xmax = 24.5,
ymin = -0.5, ymax = 24.5,
xticklabels = {},
ylabel = $\vac~(k_B \tkv/e)$,
axis on top,
]
\addplot graphics[xmin=-0.480379, xmax=24.4993, ymin=-0.480379, ymax=24.4993] {../figdata/idc_converged_bad.png};
\end{axis}
\begin{axis}[
name = iac,
at = (idc.east),
anchor = west,
title = $I_\mathrm{osc}$,
title style = {yshift = -2mm},
xshift = 4mm,
height = 4.5cm,
width = 4.5cm,
scale only axis,
xmin = -0.5, xmax = 24.5,
ymin = -0.5, ymax = 24.5,
xticklabels = {},
yticklabels = {},
axis on top,
]
\addplot graphics[xmin=-0.480379, xmax=24.4993, ymin=-0.480379, ymax=24.4993] {../figdata/iac_converged_bad.png};
\end{axis}
\begin{axis}[
name = idc_diff,
at = (idc.south),
anchor = north,
yshift = -9mm,
title = {$|I_\mathrm{avg}(\Lambda_0=10^9\tkrg) - I_\mathrm{avg}|/I_\mathrm{avg}$},
title style = {yshift = -2mm},
height = 4.5cm,
width = 4.5cm,
scale only axis,
xmin = -0.5, xmax = 24.5,
ymin = -0.5, ymax = 24.5,
xlabel = $\vdc~(k_B \tkv/e)$,
ylabel = $\vac~(k_B \tkv/e)$,
axis on top,
]
\addplot graphics[xmin=0.480379, xmax=24.4993, ymin=-0.480379, ymax=24.4993] {../figdata/idc_diff_bad.png};
\end{axis}
\begin{axis}[
name = iac_diff,
at = (idc_diff.east),
anchor = west,
xshift = 4mm,
title = {$|I_\mathrm{osc}(\Lambda_0=10^9\tkrg) - I_\mathrm{osc}|/I_\mathrm{osc}$},
title style = {yshift = -2mm},
height = 4.5cm,
width = 4.5cm,
scale only axis,
xmin = -0.5, xmax = 24.5,
ymin = -0.5, ymax = 24.5,
xlabel = $\vdc~(k_B \tkv/e)$,
yticklabels = {},
axis on top,
]
\addplot graphics[xmin=-0.480379, xmax=24.4993, ymin=0.480379, ymax=24.4993] {../figdata/iac_diff_bad.png};
\end{axis}
%
\begin{axis}[
name = colorbar,
at = (iac.east),
anchor = west,
ymin = 0,
ymax = 1.54797,
xshift = 5mm,
enlargelimits = false,
axis on top,
width = .75em,
height = 4.5cm,
scale only axis,
tickpos = right,
tick align = outside,
xtick = \empty,
ylabel = {current $(e k_B \tkv/\hbar)$},
]
\addplot graphics[xmin=0, xmax=1, ymin=0, ymax=1.54797] {../figdata/colorbar_viridis.png};
\end{axis}
\begin{axis}[
name = colorbar,
at = (iac_diff.east),
anchor = west,
ymin = 0,
ymax = 0.0534487,
xshift = 5mm,
enlargelimits = false,
axis on top,
width = .75em,
height = 4.5cm,
scale only axis,
tickpos = right,
tick align = outside,
xtick = \empty,
ytick = {0, 0.02, 0.04},
yticklabels = {$0$, $2\%$, $4\%$},
scaled ticks = false,
ylabel = {relative deviation},
]
\addplot graphics[xmin=0, xmax=1, ymin=0, ymax=0.0534487] {../figdata/colorbar_viridis.png};
\end{axis}
\end{tikzpicture}
......@@ -8,6 +8,7 @@
height = 4cm,
ylabel = {$I(t)~(e/T)$},
xlabel = {$t~(T)$},
ylabel shift = -2mm,
xmin = -0.5, xmax = 0.5,
ymin = -3, ymax = 3,
scaled ticks = false,
......@@ -29,7 +30,8 @@
name = phase,
at = (current.east),
anchor = west,
width = 2.5cm,
xshift = 3mm,
width = 2.6cm,
height = 4cm,
%xlabel = {$\varphi$},
xlabel = {$\int_{t^*}^tds\, V(s)$},
......@@ -56,12 +58,13 @@
\end{axis}
\begin{axis}[
at = (phase.east),
xshift = 2cm,
xshift = 17mm,
anchor = west,
width = 4cm,
height = 3.2cm,
xlabel = {$t~(T)$},
ylabel = {$I(t)~(e/T)$},
ylabel shift = -4mm,
xmin = -0.5, xmax = 0.5,
ymin = -0.6, ymax = 0.6,
scaled ticks = false,
......
......@@ -47,8 +47,8 @@
\addlegendentry{$\vac=80\Omega$};
\addplot[black, mark size=3pt, only marks, mark=x] coordinates {(6,10)}; % stupid dummy entry for the legend
\addlegendentry{$\vac=80\Omega$, adiabatic};
\addplot[black, mark size=1.5pt, only marks, mark=x, forget plot] table [x=n, y=mode5508] {../figdata/harmonic_modes_adiabatic-omega20.dat};
%
\addplot[black, mark size=1.5pt, only marks, mark=x, forget plot] table [x=n, y=mode5508] {../figdata/harmonic_modes_adiabatic-omega20.dat};
\addplot[magenta, mark size=1.5pt, only marks, mark=square] table [x=n, y=i] {../figdata/harmonic_modes_vac5-omega20.dat};
\addplot[blue, mark size=1.5pt, only marks, mark=diamond] table [x=n, y=i] {../figdata/harmonic_modes_vac10-omega20.dat};
\addplot[green, mark size=1.5pt, only marks, mark=triangle] table [x=n, y=i] {../figdata/harmonic_modes_vac20-omega20.dat};
......
......@@ -12,18 +12,18 @@
\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{c04}{rgb}{.7,.25,.35}%
\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}%
\definecolor{c10}{rgb}{.67,.54,0}%
\definecolor{c12}{rgb}{.5,.75,0}%
\definecolor{c14}{rgb}{0,.62,0}%
\definecolor{c16}{rgb}{0,.8,.5}%
\definecolor{c18}{rgb}{0,.6,.7}%
\definecolor{c20}{rgb}{.25,.3,1}%
\definecolor{c22}{rgb}{.6,.35,.9}%
\definecolor{c24}{rgb}{.9,0,1}%
\definecolor{c30}{rgb}{.8,.25,.6}%
\definecolor{lightgray}{rgb}{.6,.6,.6}%
\newcommand\plotsep{0.02}%
%\tikzsetnextfilename{kogan04}%
......@@ -69,47 +69,47 @@
}%
]
\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[only marks, on layer=main, color=c06, forget plot] table[x expr={17.95*\thisrowno{1}}, 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}}, y expr={\thisrowno{0}/2 + 3*\plotsep}] {../exp_data/d764n766_didv_trace10++.txt};
\addplot[only marks, on layer=main, color=c14, forget plot] table[x expr={17.95*\thisrowno{1}}, y expr={\thisrowno{0}/2 + 2*\plotsep}] {../exp_data/d764n766_didv_trace21++.txt};
\addplot[only marks, on layer=main, color=c20, forget plot] table[x expr={17.95*\thisrowno{1}}, y expr={\thisrowno{0}/2 + 1*\plotsep}] {../exp_data/d764n766_didv_trace26++.txt};
\addplot[only marks, on layer=main, color=c24, forget plot] table[x expr={17.95*\thisrowno{1}}, y expr={\thisrowno{0}/2 + 0*\plotsep}] {../exp_data/d764n766_didv_trace40++.txt};
%
%\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};
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g0.754asym}+ 4*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.17asym} + 3*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.56asym} + 2*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.74asym} + 1*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, cyan, on layer=main] table[x expr={\thisrow{vdc}+0.3}, 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, black, line width=0.6pt, on layer=main, forget plot] table[x expr={\thisrow{vdc}+0.3}, 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 expr={\thisrow{vdc}+0.3}, 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 expr={\thisrow{vdc}+0.3}, 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 expr={\thisrow{vdc}+0.3}, 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 expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g3.62} + 0*\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{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, color=white, opacity=0.8, line width=1.65pt, forget plot] table[x expr={\thisrow{vdc}+0.3}, 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 expr={\thisrow{vdc}+0.3}, 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 expr={\thisrow{vdc}+0.3}, 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 expr={\thisrow{vdc}+0.3}, 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 expr={\thisrow{vdc}+0.3}, 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, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g0.754}+ 4*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.17} + 3*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.56} + 2*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.74} + 1*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, on layer=main] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g3.74} + 0*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c06] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g0.729asym}+ 4*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c08] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.13asym} + 3*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c14] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.51asym} + 2*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c20] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.68asym} + 1*\plotsep}] {../figdata/kogan04.dat};
\addplot[frtrg style, on layer=main, color=c24] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g3.62asym} + 0*\plotsep}] {../figdata/kogan04.dat};
%
\addplot[frtrg style, black, line width=0.6pt] coordinates {(8,0) (9,0)};
%
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g0.729pat}+ 4*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g1.13pat} + 3*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g1.51pat} + 2*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g1.68pat} + 1*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x={vdc}, y expr={\thisrow{g3.62pat} + 0*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g0.729pat}+ 4*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.13pat} + 3*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.51pat} + 2*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g1.68pat} + 1*\plotsep}] {../figdata/kogan04.dat};
%\addplot[frtrg style, color=lightgray, line width=0.4pt, on layer=main, forget plot] table[x expr={\thisrow{vdc}+0.3}, y expr={\thisrow{g3.62pat} + 0*\plotsep}] {../figdata/kogan04.dat};
\end{axis}
\end{tikzpicture}
......@@ -30,6 +30,8 @@
]
\node[anchor=north west] at (axis description cs:0.03,0.97) {(a)};
\draw[gray, line width = 0.05ex] (-0.05,0) -- (0.08,0);
\addplot[fill, draw=none, color=black, no marks, opacity=0.333333] table [x=t, y expr={2.5*\thisrow{u} - 2.8}] {../figdata/pulse_current_zoom.dat};
\node at (0,-1.8) {$V(t)$};
\addplot[frtrg style, blue, no marks] table [x=t, y=i1] {../figdata/pulse_current_zoom.dat};
\addplot[frtrg style, green, no marks] table [x=t, y=i2] {../figdata/pulse_current_zoom.dat};
\addplot[frtrg style, orange, no marks] table [x=t, y=i3] {../figdata/pulse_current_zoom.dat};
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Please register or to comment