SCIPY

SciPy is an open-source Python library used for scientific and technical computing. It builds on NumPy and provides additional functionality for optimization, integration, interpolation, eigenvalue problems, algebraic equations, and other advanced mathematical tasks. SciPy is widely used in fields such as data science, machine learning, physics, and engineering.

Key Features:

Optimization: Functions for finding minima, maxima, and solving optimization problems (e.g., scipy.optimize).

Integration: Tools for numerical integration and solving ordinary differential equations (e.g., scipy.integrate).

Linear Algebra: Functions for solving linear systems, matrix operations, and eigenvalue problems (e.g., scipy.linalg).

Statistics: Statistical functions, distributions, and hypothesis testing (e.g., scipy.stats).

Signal Processing: Tools for filtering, Fourier transforms, and signal analysis (e.g., scipy.signal).

Sparse Matrices: Support for sparse matrix operations (e.g., scipy.sparse).

Special Functions: A collection of mathematical special functions (e.g., scipy.special)

SciPy Tutorial

1
SciPy Intro
10 minutes

SciPy is an open-source Python library used for scientific and technical computing, providing tools for optimization, integration, interpolation, and more.

SciPy Getting Started

1
SciPy Getting Started
10 minutes

SciPy Getting Started refers to the process of learning how to install and use SciPy, a Python library for scientific and technical computing, including various functions for optimization, integration, interpolation, and more.

2
Checking SciPy Version
10 minutes

Checking SciPy version refers to the process of verifying the installed version of the SciPy library in your Python environment using scipy.__version__.

SciPy Constant

1
SciPy Constant
10 minutes

SciPy constants are predefined mathematical constants, such as pi and Euler's number, provided in the scipy.constants module for use in scientific computations.

2
Metric (SI) Prefixes:
10 minutes

Metric (SI) prefixes are standardized symbols used to represent powers of ten for units of measurement, such as kilo (k), mega (M), and milli (m), in the International System of Units (SI).

3
Angle:
10 minutes

An angle is the space between two intersecting lines or planes, measured in degrees or radians.

4
Pressure:
10 minutes

Pressure is the force exerted per unit area, commonly measured in pascals (Pa) or other units such as atmospheres (atm) or bar.

5
Temperature:
10 minutes

Temperature is a measure of the average kinetic energy of the particles in a substance, typically expressed in degrees Celsius (°C), Fahrenheit (°F), or Kelvin (K).

SciPy Optimizers

1
SciPy Optimizers
10 minutes

SciPy optimizers are algorithms provided in the scipy.optimize module for finding the minimum or maximum of a function, including methods for both unconstrained and constrained optimization problems.

2
Minimizing a Function
10 minutes

Minimizing a function involves finding the input values that result in the lowest possible output of the function.

SciPy Sparse Data

1
SciPy Sparse Data
10 minutes

SciPy sparse data refers to data structures provided by the scipy.sparse module for efficiently storing and manipulating large datasets with mostly zero or empty elements.

2
Sparse Matrix Methods
10 minutes

Sparse matrix methods are operations and functions in the scipy.sparse module designed for efficient manipulation and analysis of sparse matrices.

SciPy Graph

1
SciPy Graph
10 minutes

SciPy graphs are data structures provided by the scipy.sparse.csgraph module for representing and analyzing sparse graphs and networks efficiently.

2
Dijkstra
10 minutes

Dijkstra's algorithm is a shortest-path algorithm that finds the minimum distance from a source node to all other nodes in a weighted graph.

3
Bellman Ford
10 minutes

Bellman-Ford is an algorithm used to find the shortest path from a single source node to all other nodes in a graph, even with negative edge weights.

SciPy Spatial Data

1
SciPy Spatial Data
10 minutes

SciPy Spatial Data refers to data structures and algorithms in the scipy.spatial module used for geometric and spatial operations, such as distance calculations, nearest neighbors, and spatial indexing.

2
Convex Hull
10 minutes

A convex hull is the smallest convex boundary that encloses a set of points in a geometric space.

3
Distance Matrix
10 minutes

A distance matrix is a square matrix that represents the pairwise distances between a set of points or elements.

4
Cosine Distance
10 minutes

Cosine distance measures the dissimilarity between two vectors by calculating the cosine of the angle between them.

SciPy Matlab Arrays

1
SciPy Matlab Arrays
10 minutes

SciPy Matlab arrays are data structures in SciPy that mimic MATLAB arrays, enabling efficient numerical computations and matrix operations in Python.

2
Import Data from Matlab Format
10 minutes

Importing data from a MATLAB format involves loading MATLAB .mat files into Python for further analysis or processing.

SciPy Interpolation

1
SciPy Interpolation
10 minutes

SciPy interpolation refers to the process of estimating values between known data points using various interpolation methods provided in the scipy.interpolate module.

 

2
Spline Interpolation
10 minutes

Spline interpolation is a method of estimating values between data points using piecewise polynomial functions, typically cubic splines, to ensure smoothness and continuity.

3
Interpolation with Radial Basis Function
10 minutes

Interpolation with Radial Basis Function (RBF) involves using radial basis functions to estimate values at unmeasured points, typically providing smooth, multi-dimensional interpolation.

SciPy Significance Tests

1
SciPy Significance Tests
10 minutes

SciPy statistical significance tests are methods provided in the scipy.stats module to assess whether the results of a hypothesis test are statistically significant, typically using p-values.

2
Alternate Hypothesis
10 minutes

The alternate hypothesis is a statement suggesting there is an effect, difference, or relationship in the population, contrary to the null hypothesis.

3
Alpha value
10 minutes

The alpha value is the threshold for statistical significance, representing the probability of rejecting a true null hypothesis, commonly set at 0.01, 0.05, or 0.1.

4
T-Test
10 minutes

A T-test is a statistical test used to determine if there is a significant difference between the means of two groups.

5
KS-Test
10 minutes

The KS-test (Kolmogorov-Smirnov test) is a statistical test used to compare two samples or a sample with a reference distribution to determine if they are drawn from the same distribution.

6
Normality Tests (Skewness and Kurtosis)
10 minutes

Normality tests (Skewness and Kurtosis) are used to assess whether a dataset follows a normal distribution by evaluating its symmetry (skewness) and the peakedness (kurtosis) of its distribution.

Be the first to add a review.

Please, login to leave a review
Start course
Enrolled: 0 students
Lectures: 30
Level: Beginner

Archive

Working hours

Monday 9:30 am - 6.00 pm
Tuesday 9:30 am - 6.00 pm
Wednesday 9:30 am - 6.00 pm
Thursday 9:30 am - 6.00 pm
Friday 9:30 am - 5.00 pm
Saturday Closed
Sunday Closed
SCIPY
Category: