mirror of
https://github.com/Telecominfraproject/oopt-gnpy.git
synced 2025-11-02 19:18:02 +00:00
Management of lumped losses along a fiber span
The lumped losses are used in the computation of the loss/gain profile through the fiber whether the Raman effect is considered or not. The computed power profile is used to calculate the related NLI impairment. Using the 'gn_model_analytic' method, the lumped losses are taken into account as the contribution of an additional total loss at the end of the fiber span. In case the 'ggn_spectrally_separated' is selected, the method uses the computed power profile according to the specified z and frequency arrays. The lumped losses are so considered within the NLI power evolution along the fiber. Change-Id: I73a6baa321aca4d041cafa180f47afed824ce267 Signed-off-by: Jan Kundrát <jan.kundrat@telecominfraproject.com>
This commit is contained in:
committed by
Jan Kundrát
parent
5e50ffbbf6
commit
aaf0480e9c
@@ -11,7 +11,8 @@ The solvers take as input instances of the spectral information, the fiber and t
|
||||
"""
|
||||
|
||||
from numpy import interp, pi, zeros, shape, where, cos, array, append, ones, exp, arange, sqrt, empty, trapz, arcsinh, \
|
||||
clip, abs, sum, concatenate, flip, outer, inner, transpose, max, format_float_scientific, diag
|
||||
clip, abs, sum, concatenate, flip, outer, inner, transpose, max, format_float_scientific, diag, prod, argwhere, \
|
||||
unique, argsort, cumprod
|
||||
from logging import getLogger
|
||||
from scipy.constants import k, h
|
||||
from scipy.interpolate import interp1d
|
||||
@@ -69,6 +70,15 @@ class StimulatedRamanScattering:
|
||||
class RamanSolver:
|
||||
"""This class contains the methods to calculate the Raman scattering effect."""
|
||||
|
||||
@staticmethod
|
||||
def _create_lumped_losses(z, lumped_losses, z_lumped_losses):
|
||||
lumped_losses = concatenate((lumped_losses, ones(z.size)))
|
||||
z, unique_indices = unique(concatenate((z_lumped_losses, z)), return_index=True)
|
||||
order = argsort(z)
|
||||
lumped_losses = (lumped_losses[unique_indices])[order]
|
||||
z = z[order]
|
||||
return z, lumped_losses
|
||||
|
||||
@staticmethod
|
||||
def calculate_attenuation_profile(spectral_info: SpectralInformation, fiber):
|
||||
"""Evaluates the attenuation profile along the z axis for all the frequency propagating in the
|
||||
@@ -76,12 +86,16 @@ class RamanSolver:
|
||||
"""
|
||||
# z array definition
|
||||
z = array([0, fiber.params.length])
|
||||
|
||||
# Lumped losses array definition
|
||||
z, lumped_losses = RamanSolver._create_lumped_losses(z, fiber.lumped_losses, fiber.z_lumped_losses)
|
||||
|
||||
lumped_loss_acc = cumprod(lumped_losses)
|
||||
frequency = spectral_info.frequency
|
||||
alpha = fiber.alpha(frequency)
|
||||
loss_profile = exp(- outer(alpha, z))
|
||||
loss_profile = exp(- outer(alpha, z)) * lumped_loss_acc
|
||||
power_profile = outer(spectral_info.signal, ones(z.size)) * loss_profile
|
||||
stimulated_raman_scattering = StimulatedRamanScattering(power_profile, loss_profile, frequency, z)
|
||||
return stimulated_raman_scattering
|
||||
return StimulatedRamanScattering(power_profile, loss_profile, spectral_info.frequency, z)
|
||||
|
||||
@staticmethod
|
||||
def calculate_stimulated_raman_scattering(spectral_info: SpectralInformation, fiber):
|
||||
@@ -90,13 +104,16 @@ class RamanSolver:
|
||||
"""
|
||||
logger.debug('Start computing fiber Stimulated Raman Scattering')
|
||||
|
||||
# Raman parameters
|
||||
z_resolution = sim_params.raman_params.result_spatial_resolution
|
||||
z_step = sim_params.raman_params.solver_spatial_resolution
|
||||
z = append(arange(0, fiber.params.length, z_step), fiber.params.length)
|
||||
z_final = append(arange(0, fiber.params.length, z_resolution), fiber.params.length)
|
||||
|
||||
if sim_params.raman_params.flag:
|
||||
# Raman parameters
|
||||
z_resolution = sim_params.raman_params.result_spatial_resolution
|
||||
z_step = sim_params.raman_params.solver_spatial_resolution
|
||||
z = append(arange(0, fiber.params.length, z_step), fiber.params.length)
|
||||
z_final = append(arange(0, fiber.params.length, z_resolution), fiber.params.length)
|
||||
|
||||
# Lumped losses array definition
|
||||
z, lumped_losses = RamanSolver._create_lumped_losses(z, fiber.lumped_losses, fiber.z_lumped_losses)
|
||||
|
||||
if hasattr(fiber, 'raman_pumps'):
|
||||
# TODO: verify co-propagating pumps computation and in general unsorted frequency
|
||||
# Co-propagating spectrum definition
|
||||
@@ -119,19 +136,20 @@ class RamanSolver:
|
||||
co_cr = fiber.cr(co_frequency)
|
||||
co_alpha = fiber.alpha(co_frequency)
|
||||
co_power_profile = \
|
||||
RamanSolver.first_order_derivative_solution(co_power, co_alpha, co_cr, z)
|
||||
RamanSolver.first_order_derivative_solution(co_power, co_alpha, co_cr, z, lumped_losses)
|
||||
# Counter-propagating profile initialization
|
||||
cnt_power_profile = empty([co_frequency.size, z.size])
|
||||
if cnt_frequency.size:
|
||||
cnt_cr = fiber.cr(cnt_frequency)
|
||||
cnt_alpha = fiber.alpha(cnt_frequency)
|
||||
cnt_power_profile = \
|
||||
flip(RamanSolver.first_order_derivative_solution(cnt_power, cnt_alpha, cnt_cr, z[-1] - flip(z)))
|
||||
flip(RamanSolver.first_order_derivative_solution(cnt_power, cnt_alpha, cnt_cr,
|
||||
z[-1] - flip(z), flip(lumped_losses)))
|
||||
# Co-propagating and Counter-propagating Profile Computation
|
||||
if co_frequency.size and cnt_frequency.size:
|
||||
co_power_profile, cnt_power_profile = \
|
||||
RamanSolver.iterative_algorithm(co_power_profile, cnt_power_profile, co_frequency, cnt_frequency,
|
||||
z, fiber)
|
||||
RamanSolver.iterative_algorithm(co_power_profile, cnt_power_profile,
|
||||
co_frequency, cnt_frequency, z, fiber, lumped_losses)
|
||||
# Complete Power Profile
|
||||
power_profile = concatenate((co_power_profile, cnt_power_profile), axis=0)
|
||||
# Complete Loss Profile
|
||||
@@ -146,7 +164,7 @@ class RamanSolver:
|
||||
cr = fiber.cr(spectral_info.frequency)
|
||||
# Power profile
|
||||
power_profile = \
|
||||
RamanSolver.first_order_derivative_solution(spectral_info.signal, alpha, cr, z)
|
||||
RamanSolver.first_order_derivative_solution(spectral_info.signal, alpha, cr, z, lumped_losses)
|
||||
# Loss profile
|
||||
loss_profile = power_profile / outer(spectral_info.signal, ones(z.size))
|
||||
frequency = spectral_info.frequency
|
||||
@@ -154,7 +172,8 @@ class RamanSolver:
|
||||
loss_profile = interp1d(z, loss_profile, axis=1)(z_final)
|
||||
stimulated_raman_scattering = StimulatedRamanScattering(power_profile, loss_profile, frequency, z_final)
|
||||
else:
|
||||
stimulated_raman_scattering = RamanSolver.calculate_attenuation_profile(spectral_info, fiber)
|
||||
stimulated_raman_scattering = \
|
||||
RamanSolver.calculate_attenuation_profile(spectral_info, fiber)
|
||||
return stimulated_raman_scattering
|
||||
|
||||
@staticmethod
|
||||
@@ -181,23 +200,26 @@ class RamanSolver:
|
||||
return ase
|
||||
|
||||
@staticmethod
|
||||
def first_order_derivative_solution(power_in, alpha, cr, z):
|
||||
def first_order_derivative_solution(power_in, alpha, cr, z, lumped_losses):
|
||||
"""Solves the Raman first order derivative equation
|
||||
|
||||
:param power_in: launch power array
|
||||
:param alpha: loss coefficient array
|
||||
:param cr: Raman efficiency coefficients matrix
|
||||
:param z: z position array
|
||||
:param lumped_losses: concentrated losses array along the fiber span
|
||||
:return: power profile matrix
|
||||
"""
|
||||
dz = z[1:] - z[:-1]
|
||||
power = outer(power_in, ones(z.size))
|
||||
for i in range(1, z.size):
|
||||
power[:, i] = power[:, i - 1] * (1 + (- alpha + sum(cr * power[:, i - 1], 1)) * dz[i - 1])
|
||||
power[:, i] = \
|
||||
power[:, i - 1] * (1 + (- alpha + sum(cr * power[:, i - 1], 1)) * dz[i - 1]) * lumped_losses[i - 1]
|
||||
return power
|
||||
|
||||
@staticmethod
|
||||
def iterative_algorithm(co_initial_guess_power, cnt_initial_guess_power, co_frequency, cnt_frequency, z, fiber):
|
||||
def iterative_algorithm(co_initial_guess_power, cnt_initial_guess_power, co_frequency, cnt_frequency, z, fiber,
|
||||
lumped_losses):
|
||||
"""Solves the Raman first order derivative equation in case of both co- and counter-propagating
|
||||
frequencies
|
||||
|
||||
@@ -207,6 +229,7 @@ class RamanSolver:
|
||||
:param cnt_frequency: counter-propagationg frequencies
|
||||
:param z: z position array
|
||||
:param fiber: instance of gnpy.core.elements.Fiber or gnpy.core.elements.RamanFiber
|
||||
:param lumped_losses: concentrated losses array along the fiber span
|
||||
:return: co- and counter-propagatng power profile matrix
|
||||
"""
|
||||
logger.debug(' Start iterative algorithm')
|
||||
@@ -227,15 +250,18 @@ class RamanSolver:
|
||||
for i in range(1, z.size):
|
||||
dpdz = - alpha + sum(cr * next_power[:, i - 1], 1)
|
||||
next_power[:co_frequency.size, i] = \
|
||||
next_power[:co_frequency.size, i - 1] * (1 + dpdz[:co_frequency.size] * dz[i - 1])
|
||||
next_power[:co_frequency.size, i - 1] * (1 + dpdz[:co_frequency.size] * dz[i - 1]) * \
|
||||
lumped_losses[i - 1]
|
||||
for i in range(1, z.size):
|
||||
dpdz = - alpha + sum(cr * next_power[:, -i], 1)
|
||||
next_power[co_frequency.size:, -i - 1] = \
|
||||
next_power[co_frequency.size:, -i] * (1 + dpdz[co_frequency.size:] * dz[-i])
|
||||
next_power[co_frequency.size:, -i] * (1 + dpdz[co_frequency.size:] * dz[-i]) * \
|
||||
lumped_losses[-i]
|
||||
|
||||
dpdz_num = (next_power[:co_frequency.size, 1:] - next_power[:co_frequency.size, :-1]) / dz
|
||||
dpdz_exp = next_power[:co_frequency.size, :-1] * \
|
||||
(- outer(alpha, ones(z.size)) + inner(cr, transpose(next_power)))[:co_frequency.size, :-1]
|
||||
(- outer(alpha, ones(z.size)) + inner(cr, transpose(next_power)))[:co_frequency.size, :-1] * \
|
||||
lumped_losses[:-1]
|
||||
|
||||
residue = max(abs((next_power - prev_power) / next_power))
|
||||
accuracy = max(abs((dpdz_exp - dpdz_num) / dpdz_exp))
|
||||
|
||||
Reference in New Issue
Block a user