diff --git a/matlab/AddCPWPort.m b/matlab/AddCPWPort.m index d5e9b5f..94f0632 100644 --- a/matlab/AddCPWPort.m +++ b/matlab/AddCPWPort.m @@ -17,7 +17,7 @@ function [CSX,port] = AddCPWPort( CSX, prio, portnr, materialname, start, stop, % is false) % 'FeedShift' shift to port from start by a given distance in drawing % units. Default is 0. Only active if 'ExcitePort' is set! -% 'Feed_R' Specifiy a lumped port resistance. Default is no lumped +% 'Feed_R' Specify a lumped port resistance. Default is no lumped % port resistance --> port has to end in an ABC. % 'MeasPlaneShift' Shift the measurement plane from start t a given distance % in drawing units. Default is the middle of start/stop. diff --git a/matlab/AddCoaxialPort.m b/matlab/AddCoaxialPort.m index 9c94723..90696f8 100644 --- a/matlab/AddCoaxialPort.m +++ b/matlab/AddCoaxialPort.m @@ -20,7 +20,7 @@ function [CSX,port] = AddCoaxialPort( CSX, prio, portnr, pec_name, materialname, % set to 0 (default) for a passive port % 'FeedShift' shift to port from start by a given distance in drawing % units. Default is 0. Only active if 'ExciteAmp' is set! -% 'Feed_R' Specifiy a lumped port resistance. Default is no lumped +% 'Feed_R' Specify a lumped port resistance. Default is no lumped % port resistance --> port has to end in an ABC. % 'MeasPlaneShift' Shift the measurement plane from start t a given distance % in drawing units. Default is the middle of start/stop. @@ -213,7 +213,7 @@ if (excite_amp~=0) CSX = AddCylindricalShell(CSX,[PortNamePrefix 'port_excite_' num2str(portnr)],0 ,ex_start,ex_stop,0.5*(r_i+r_o),(r_o-r_i)); end -%% resitance at start of coaxial line +%% resistance at start of coaxial line ex_start = start; ex_stop = stop; ex_stop(idx_prop_n) = ex_start(idx_prop_n); @@ -227,6 +227,6 @@ elseif feed_R == 0 CSX = AddBox( CSX, pec_name, prio, ex_start, ex_stop ); CSX = AddCylindricalShell(CSX, pec_name, prio ,ex_start, ex_stop, 0.5*(r_i+r_o),(r_o-r_i)); else - error('openEMS:AddMSLPort','MSL port with resitance <= 0 it not possible'); + error('openEMS:AddMSLPort','MSL port with resistance <= 0 it not possible'); end end diff --git a/matlab/AddLumpedPort.m b/matlab/AddLumpedPort.m index ad6d5fa..0c4f085 100644 --- a/matlab/AddLumpedPort.m +++ b/matlab/AddLumpedPort.m @@ -15,8 +15,8 @@ function [CSX, port] = AddLumpedPort( CSX, prio, portnr, R, start, stop, dir, ex % dir: direction/amplitude of port (e.g.: [1 0 0], [0 1 0] or [0 0 1]) % excite (optional): if true, the port will be switched on (see AddExcitation()) % Note: for legacy support a string will be accepted -% V_Probe_Weight: additional weigth for the voltage probes -% I_Probe_Weight: additional weigth for the current probes +% V_Probe_Weight: additional weight for the voltage probes +% I_Probe_Weight: additional weight for the current probes % optional (key/values): % 'PortNamePrefix': an prefix to the port name % varargin (optional): additional excitations options, see also AddExcitation @@ -25,7 +25,7 @@ function [CSX, port] = AddLumpedPort( CSX, prio, portnr, R, start, stop, dir, ex % start = [0 -width/2 0]; % stop = [0 width/2 height]; % [CSX] = AddLumpedPort(CSX, 5 ,1 , 50, start, stop, [0 0 1], true); -% %this defines an active lumped port in z-direction with a 50 Ohm port impedence +% %this defines an active lumped port in z-direction with a 50 Ohm port impedance % % openEMS matlab interface % ----------------------- @@ -94,7 +94,7 @@ end % legacy support, will be removed at some point if ischar(excite) - warning('CSXCAD:AddLumpedPort','depreceated: a string as excite option is no longer supported and will be removed in the future, please use true or false'); + warning('CSXCAD:AddLumpedPort','deprecated: a string as excite option is no longer supported and will be removed in the future, please use true or false'); if ~isempty(excite) excite = true; else diff --git a/matlab/AddMSLPort.m b/matlab/AddMSLPort.m index bd4c6ab..e541719 100644 --- a/matlab/AddMSLPort.m +++ b/matlab/AddMSLPort.m @@ -16,7 +16,7 @@ function [CSX,port] = AddMSLPort( CSX, prio, portnr, materialname, start, stop, % is false) % 'FeedShift' shift to port from start by a given distance in drawing % units. Default is 0. Only active if 'ExcitePort' is set! -% 'Feed_R' Specifiy a lumped port resistance. Default is no lumped +% 'Feed_R' Specify a lumped port resistance. Default is no lumped % port resistance --> port has to end in an ABC. % 'MeasPlaneShift' Shift the measurement plane from start t a given distance % in drawing units. Default is the middle of start/stop. @@ -37,7 +37,7 @@ function [CSX,port] = AddMSLPort( CSX, prio, portnr, materialname, start, stop, % - the excitation is active and placed at x=start(1) ('ExcitePort', true) % - a 50 Ohm lumped port resistance is placed at x=start(1) ('Feed_R', 50) % - the width-direction is determined by the cross product of the -% direction of propagtion (dir='x') and the excitation vector +% direction of propagation (dir='x') and the excitation vector % (evec=[0 0 -1]), in this case it is the y-direction % - the MSL-metal is created in a xy-plane at a height at z=start(3) % --> It is important to define the MSL height in the start coordinate! @@ -95,7 +95,7 @@ for n=1:2:numel(varargin) end elseif (strcmp(varargin{n},'ExcitePort')==1); if ischar(varargin{n+1}) - warning('CSXCAD:AddMSLPort','depreceated: a string as excite option is no longer supported and will be removed in the future, please use true or false'); + warning('CSXCAD:AddMSLPort','deprecated: a string as excite option is no longer supported and will be removed in the future, please use true or false'); if ~isempty(excite) excite = true; else @@ -247,7 +247,7 @@ if excite CSX = AddBox( CSX, [PortNamePrefix 'port_excite_' num2str(portnr)], prio, ex_start, ex_stop ); end -%% MSL resitance at start of MSL line +%% MSL resistance at start of MSL line ex_start(idx_prop) = start(idx_prop); ex_stop(idx_prop) = ex_start(idx_prop); @@ -260,6 +260,6 @@ elseif feed_R == 0 %port "resistance" as metal CSX = AddBox( CSX, materialname, prio, ex_start, ex_stop ); else - error('openEMS:AddMSLPort','MSL port with resitance <= 0 it not possible'); + error('openEMS:AddMSLPort','MSL port with resistance <= 0 it not possible'); end end diff --git a/matlab/AddStripLinePort.m b/matlab/AddStripLinePort.m index af73e54..7030974 100644 --- a/matlab/AddStripLinePort.m +++ b/matlab/AddStripLinePort.m @@ -68,7 +68,7 @@ evec0 = evec ./ sum(evec); % evec0 is a unit vector %set defaults feed_shift = 0; -feed_R = inf; %(default is open, no resitance) +feed_R = inf; %(default is open, no resistance) excite = false; measplanepos = nan; PortNamePrefix = ''; @@ -84,12 +84,12 @@ for n=1:2:numel(varargin) end elseif (strcmp(varargin{n},'Feed_R')==1); feed_R = varargin{n+1}; - if (numel(feed_R)>1) + if (numel(feed_shift)>1) error 'Feed_R must be a scalar value' end elseif (strcmp(varargin{n},'MeasPlaneShift')==1); measplanepos = varargin{n+1}; - if (numel(measplanepos)>1) + if (numel(feed_shift)>1) error 'MeasPlaneShift must be a scalar value' end elseif (strcmp(varargin{n},'ExcitePort')==1); @@ -263,7 +263,7 @@ if excite CSX = AddBox( CSX, [PortNamePrefix 'port_excite_2_' num2str(portnr)], prio, ex_start, ex_stop-height_vector ); end -%% MSL resitance at start of MSL line +%% MSL resistance at start of MSL line ex_start(idx_prop) = start(idx_prop); ex_stop(idx_prop) = ex_start(idx_prop); @@ -278,6 +278,6 @@ elseif feed_R == 0 CSX = AddBox( CSX, materialname, prio, ex_start, ex_stop+height_vector ); CSX = AddBox( CSX, materialname, prio, ex_start, ex_stop-height_vector ); else - error('openEMS:AddMSLPort','MSL port with resitance <= 0 it not possible'); + error('openEMS:AddMSLPort','MSL port with resistance <= 0 it not possible'); end end diff --git a/matlab/ConvertHDF5_VTK.m b/matlab/ConvertHDF5_VTK.m index 545ba01..ff9af8f 100644 --- a/matlab/ConvertHDF5_VTK.m +++ b/matlab/ConvertHDF5_VTK.m @@ -15,7 +15,7 @@ function ConvertHDF5_VTK(hdf_file, vtk_prefix, varargin) % 'FieldName': field name written to vtk, e.g. 'E-Field' % 'weight': field weighting % -% for more optional aguments have a look at ReadHDF5Dump +% for more optional augments have a look at ReadHDF5Dump % % example: % % read time-domian data from hdf5, perform dft and dump as vtk diff --git a/matlab/DelayFidelity.m b/matlab/DelayFidelity.m index 48d5975..b94247e 100644 --- a/matlab/DelayFidelity.m +++ b/matlab/DelayFidelity.m @@ -79,12 +79,12 @@ radfield ./= radnorm; %initialize radiated field in fully populated frequency domain rad_f = zeros([numel(nf2ff.theta), numel(nf2ff.phi), numel(fport)]); rad_f(:, :, f_ind) = radfield; % assign selected frequencies -exc_f = reshape(exc_f, [1,1,numel(exc_f)]); %make exc_f confomant with rad_f +exc_f = reshape(exc_f, [1,1,numel(exc_f)]); %make exc_f conformant with rad_f cr_f = rad_f .* conj(exc_f); % calculate cross correlation % calculate the cross correlation in time domain (analytic signal) cr = ifft(cr_f(:, :, 1:end-1), [], 3) * (numel(fport) -1); % twice the FFT normalization (sqrt^2) because product of two normalized functions -%search for the maxiumum of the envelope +%search for the maximum of the envelope [fidelity, delay_ind] = max(abs(cr), [], 3); delay = (delay_ind - 1) * dt * 2; % double time step because of single-sided FFT nf2ff_out = nf2ff; %possibly needed for plotting the far field and other things diff --git a/matlab/DumpFF2VTK.m b/matlab/DumpFF2VTK.m index 8e6e2f8..27d2659 100644 --- a/matlab/DumpFF2VTK.m +++ b/matlab/DumpFF2VTK.m @@ -5,16 +5,16 @@ function DumpFF2VTK(filename, farfield, thetaRange, phiRange, varargin) % % input: % filename: filename of VTK file, existing file will be overwritten -% farfield: farfield in V/m +% farfield: far field in V/m % thetaRange: theta range in deg % phiRange: phi range in deg % % variable input: % 'scale': - linear scale of plot, doesn't affect gain values -% 'logscale': - if set, show farfield with logarithmic scale +% 'logscale': - if set, show far field with logarithmic scale % - set the dB value for point of origin % - values below will be clamped -% 'maxgain': - add max gain in dB to normalized farfield +% 'maxgain': - add max gain in dB to normalized far field % - only valid if logscale is set % - default is 0dB % diff --git a/matlab/GetField_Interpolation.m b/matlab/GetField_Interpolation.m index 6682a83..cd743b2 100644 --- a/matlab/GetField_Interpolation.m +++ b/matlab/GetField_Interpolation.m @@ -3,9 +3,9 @@ function [field_i mesh_i] = GetField_Interpolation(field, mesh, lines, varargin) % % Get an interpolated field, e.g. read by ReadHDF5Dump % -% homogen interpolation given by a 3x1 vector: e.g. [21,1,101] +% homogeneous interpolation given by a 3x1 vector: e.g. [21,1,101] % -% abitrary interpolation on a given mesh: +% arbitrary interpolation on a given mesh: % e.g.: mesh_interp{1} = linspace(0, 1,101) * 1e-3; % mesh_interp{2} = linspace(0,0.5, 51) * 1e-3; % mesh_interp{3} = linspace(0,0.2, 21) * 1e-3; diff --git a/matlab/GetField_TD2FD.m b/matlab/GetField_TD2FD.m index 014c6d6..db31ad6 100644 --- a/matlab/GetField_TD2FD.m +++ b/matlab/GetField_TD2FD.m @@ -2,7 +2,7 @@ function field = GetField_TD2FD(field, freq) % function field = GetField_TD2FD(field, freq) % % Transforms time-domain field data into the frequency domain -% Autocorrects the half-timestep offset of the H-field +% Auto-corrects the half-timestep offset of the H-field % % example: % freq = linspace(0,1e9,100); %target frequency vector (Hz) diff --git a/matlab/PlotHDF5FieldData.m b/matlab/PlotHDF5FieldData.m index 9aaf899..a1c29af 100644 --- a/matlab/PlotHDF5FieldData.m +++ b/matlab/PlotHDF5FieldData.m @@ -25,7 +25,7 @@ mesh = ReadHDF5Mesh(file); fields = ReadHDF5FieldData(file); if (mesh.type==0) - % cartesian mesh + % Cartesian mesh [X Y Z] = meshgrid(mesh.lines{1},mesh.lines{2},mesh.lines{3}); for n=1:numel(fields.TD.values) % since Matlab 7.1SP3 the field needs to be reordered diff --git a/matlab/ReadHDF5Mesh.m b/matlab/ReadHDF5Mesh.m index b276391..40e90a1 100644 --- a/matlab/ReadHDF5Mesh.m +++ b/matlab/ReadHDF5Mesh.m @@ -4,7 +4,7 @@ function hdf_mesh = ReadHDF5Mesh(file) % Get the raw mesh data stored in the hdf5 dump file created by openEMS % % returns: -% hdf_mesh.type (0-> cartesian, 1-> cylindrical mesh type) +% hdf_mesh.type (0-> Cartesian, 1-> cylindrical mesh type) % hdf_mesh.names (e.g. 'Mesh/y') % hdf_mesh.lines (e.g. [0,1,2,3,4]) % @@ -56,7 +56,7 @@ hdf_mesh.type=0; function hdf_mesh = ReadHDF5Mesh_octave(file) hdf = load( '-hdf5', file ); hdf_mesh.names = fieldnames(hdf.Mesh); -hdf_mesh.type = 0; % cartesian mesh +hdf_mesh.type = 0; % Cartesian mesh for n=1:numel(hdf_mesh.names) hdf_mesh.lines{n} = hdf.Mesh.(hdf_mesh.names{n}); hdf_mesh.names{n} = ['/Mesh/' hdf_mesh.names{n}]; diff --git a/matlab/RunOpenEMS.m b/matlab/RunOpenEMS.m index 21a9876..938814b 100644 --- a/matlab/RunOpenEMS.m +++ b/matlab/RunOpenEMS.m @@ -4,7 +4,7 @@ function RunOpenEMS(Sim_Path, Sim_File, opts, Settings) % Run an openEMS simulation. % % arguments: -% Sim_Path: specifiy the simulation folder (folder must exist!) +% Sim_Path: specify the simulation folder (folder must exist!) % Sim_File: xml-filename to simulate, created by WriteOpenEMS % % optional arguments diff --git a/matlab/RunOpenEMS_MPI.m b/matlab/RunOpenEMS_MPI.m index 779b038..af6d375 100644 --- a/matlab/RunOpenEMS_MPI.m +++ b/matlab/RunOpenEMS_MPI.m @@ -100,7 +100,7 @@ end if isfield(Settings.MPI,'Hosts') disp( 'Remote simulation done... copying back results and cleaning up...' ); - if (strncmp(work_path,'/tmp/',5)~=1) % savety precaution... + if (strncmp(work_path,'/tmp/',5)~=1) % safety precaution... error('openEMS:RunOpenEMS','working path invalid for deletion'); end diff --git a/matlab/RunOpenEMS_Parallel.m b/matlab/RunOpenEMS_Parallel.m index cd5d4bd..c42f408 100644 --- a/matlab/RunOpenEMS_Parallel.m +++ b/matlab/RunOpenEMS_Parallel.m @@ -7,9 +7,9 @@ function [stdout, stderr] = RunOpenEMS_Parallel(Sim_Paths, Sim_Files, opts, Sett % This function relies on InitQueue etc. % % input: -% Sim_Paths: cell array of pathes to simulate by RunOpenEMS +% Sim_Paths: cell array of paths to simulate by RunOpenEMS % Sim_Files: filename or cell array of filenames to simulate -% opts: openEMS options. sa RunOpenEMS +% opts: openEMS options. see also RunOpenEMS % Settings: use the settings to define multiple host for simulation % e.g.: Settings.SSH.bin ='/openEMS.sh'; % Settings.SSH.host_list = {'list','of','hosts'}; diff --git a/matlab/SetCustomExcite.m b/matlab/SetCustomExcite.m index 6f87a49..439ca63 100644 --- a/matlab/SetCustomExcite.m +++ b/matlab/SetCustomExcite.m @@ -2,7 +2,7 @@ function FDTD = SetCustomExcite(FDTD,f0,funcStr) % function FDTD = SetCustomExcite(FDTD,f0,funcStr) % % f0 : nyquist rate -% funcStr : string desribing the excitation function e(t) +% funcStr : string describing the excitation function e(t) % % see also SetSinusExcite SetGaussExcite % diff --git a/matlab/calcLumpedPort.m b/matlab/calcLumpedPort.m index 69dba69..b9a9686 100644 --- a/matlab/calcLumpedPort.m +++ b/matlab/calcLumpedPort.m @@ -24,7 +24,7 @@ function [port] = calcLumpedPort( port, SimDir, f, varargin) % port.it.time current time vector % % % output signals/values in frequency domain (FD): -% port.f the given frequency fector +% port.f the given frequency factor % port.uf.tot/inc/ref total, incoming and reflected voltage % port.if.tot/inc/ref total, incoming and reflected current % diff --git a/matlab/optimizer_asco_sim.m b/matlab/optimizer_asco_sim.m index 6f62ebf..bbecd85 100644 --- a/matlab/optimizer_asco_sim.m +++ b/matlab/optimizer_asco_sim.m @@ -5,9 +5,9 @@ function optimizer_asco_sim( optimdir, inputfile, outputfile, simfun ) % % tasks: % - set correct matlab path -% - evaluate inputfile +% - evaluate input file % - start simulation or get result from cache -% - postprocess simulation results +% - post-process simulation results % - create output file (important: needs single \n at the first line and double \n at the last line!) error( nargchk(4,4,nargin) ); diff --git a/matlab/physical_constants.m b/matlab/physical_constants.m index cbb333e..8cb623a 100644 --- a/matlab/physical_constants.m +++ b/matlab/physical_constants.m @@ -4,7 +4,7 @@ % Bronstein 3rd ed., 1997, pp. 945-946 C0 = 299792458; % m/s -c0 = C0; %constans in capital letters, c0 for legacy support +c0 = C0; % constants in capital letters, c0 for legacy support MUE0 = 4e-7*pi; % N/A^2 EPS0 = 1/(MUE0*C0^2); % F/m diff --git a/matlab/plotFF3D.m b/matlab/plotFF3D.m index 45950c8..617d9ad 100644 --- a/matlab/plotFF3D.m +++ b/matlab/plotFF3D.m @@ -9,7 +9,7 @@ function h = plotFF3D(nf2ff,varargin) % variable input: % 'freq_index': - use the given frequency index, see nf2ff.freq % - default is 1 -% 'logscale': - if set, show farfield with logarithmic scale +% 'logscale': - if set, show far field with logarithmic scale % - set the dB value for point of origin % - values below will be clamped % 'normalize': - true/false, normalize linear plot